
NIRISS Wide Field Slitless Spectroscopy (WFSS) Pipeline Notebook#
Authors: R. Plesha
Last Updated: September 10, 2025
Pipeline Version: 1.19.1 (Build 12.0)
Purpose:#
This notebook provides a framework for processing generic Near-Infrared Imager and Slitless Spectrograph (NIRISS) wide field slitless spectroscopy (WFSS) data through the James Webb Space Telescope (JWST) pipeline. Data from a single proposal and observation ID is assumed to be located in one observation folder according to paths set up below. It should not be necessary to edit any cells other than in the Configuration section unless modifying the standard pipeline processing options. Additional notebooks showing how to optimize and modify sources being extracted for NIRISS WFSS data can be found on the JDAT notebooks github.
Data: This example uses data from the Program ID 2079 observation 004 (PI: Finkelstein) observing the Hubble Ultra Deep Field (HUDF). The observations are in three NIRISS filters: F115W, F150W, and F200W use both GR150R and GR150C grisms. In this example we are only looking at data from one of the two observations using the F200W filter. A NIRISS WFSS observation sequence typically consists of a direct image followed by a grism observation in the same blocking filter to help identify the sources in the field. In program 2079, the exposure sequence follows the pattern: direct image -> GR150R -> direct image -> GR150C -> direct image.
Example input data to use will be downloaded automatically unless disabled by the dodownload
parameter (i.e., to use local files instead).
JWST pipeline version and CRDS context: This notebook was written for the calibration pipeline version given above. The JWST Calibration Reference Data System (CRDS) context used is associated with the pipeline version as listed here. If you use different pipeline version or CRDS context, please read the relevant release notes (here for pipeline, here for CRDS) for possibly relevant changes. The results of this notebook may differ from the products hosted on the MAST archive depending on the pipeline version and CRDS context you are using.
Updates: This notebook is regularly updated as improvements are made to the pipeline. Find the most up to date version of this notebook at: https://github.com/spacetelescope/jwst-pipeline-notebooks/
Recent Changes:
September 10, 2025: original notebook released
Table of Contents#
Configuration
Package Imports
Directory Setup
Demo Mode Setup (Data Download)
Detector 1 Pipeline
Image2 Pipeline
Image3 Pipeline
Visualize the source catalog
Spec2 Pipeline
Spec3 Pipeline
Visualize the Spectra
1. Configuration#
Set basic configuration for running notebook.
Install dependencies and parameters#
To make sure that the pipeline version is compatabile with the steps
discussed below and the required dependencies and packages are installed,
you can create a fresh conda environment and install the provided
requirements.txt
file:
conda create -n niriss_wfss_pipeline python=3.12
conda activate niriss_wfss_pipeline
pip install -r requirements.txt
Set the basic parameters to use with this notebook. These will affect what data is used, where data is located (if already in disk), names of any outputs, and pipeline modules run in this data. The list of parameters are:
demo_mode
sci_dir (directory where the data is / will be)
dodownload (download the data locally)
pipeline modules:
dodet1 (run detector1)
doimage2 (run image2)
doimage3 (run image3)
dospec2 (run spec2)
dospec3 (run spec3)
doviz (show visualizations of the data within the notebook)
program (proposal ID of your data for the level 3 association files)
sci_observtn (observation of your data for level 3 the association files)
# Basic import necessary for configuration
import os
# establishing what directory we're currently working in
cwd = os.getcwd()
demo_mode
runs correctly.
Set demo_mode = True
to run in demonstration mode. In this mode this notebook will download example data from the Barbara A.
Mikulski Archive for Space Telescopes (MAST) and process everything through the pipeline. This will all happen in a local directory unless modified in the configuration below (variable data_dir
).
# -----------------------------Demo Mode---------------------------------
# use the provided example for demonstration purposes
demo_mode = True
if demo_mode:
program = '02079'
sci_observtn = '004' # as an example; 001 also exists for this program
# creating a directory for the data called "nis_wfss_demo_data"
# located in the directory you are currently in
data_dir = os.path.join(cwd, 'nis_wfss_demo_data')
sci_dir = os.path.join(data_dir, f"PID{program}/obs{sci_observtn}")
print(f'Running in demonstration mode using example data from program {program} obs{sci_observtn}!')
print(f'Data located in: {sci_dir}')
# you will want to download the demo data
dodownload = True
Running in demonstration mode using example data from program 02079 obs004!
Data located in: /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004
Set demo_mode = False
if you want to process your own data that has already been downloaded. To do so, in the cell below, provide the program ID in the program
variable, the observation ID in the sci_observtn
variable, and the top path level location of the data in the sci_dir
variable. The notebook expects that the uncal
files are in a directory under sci_dir
called uncal
.
If you would like to additionally download the data for a specific program through this notebook, you can additionally set the dodownload
variable to True below, and the data will be downloaded to the provided sci_dir
directory.
# --------------------------User Mode Directories------------------------
# If demo_mode = False, look for user data in these paths
if not demo_mode:
# Set directory paths for processing specific data; these will need
# to be changed to your local directory setup (below are given as
# examples)
user_home_dir = os.path.expanduser('~')
# Point to where science observation data are
# Assumes uncalibrated data in sci_dir/uncal/ and results in stage1,
# stage2, stage3 directories
program = '02079' # modify this to your specific program
sci_observtn = '004' # modify this to your specific program
sci_dir = os.path.join(user_home_dir, f'nis_wfss_demo_data/PID{program}/obs{sci_observtn}/')
dodownload = False # if you would like to download your data using astroquery, set to True & don't skip Demo mode setup section
print(f'Running using user input data from: {sci_dir} for program {program} obs{sci_observtn}')
Set any of the variables below to be True (do the processing) or False (don’t do the processing). To run this notebook from start to completion, it is expected that the output products from each of the stages below are located in the appropriate directories as set in #3.-Directory Setup. If these output products do not exist, any of the later stages of the pipeline may not work as intended.
# --------------------------Set Processing Steps--------------------------
# Individual pipeline stages can be turned on/off here. Note that a later
# stage won't be able to run unless data products have already been
# produced from the prior stage.
# visualization of products within the notebook
doviz = True # Visualize outputs
# Science processing
dodet1 = True # calwebb_detector1; files saved in "stage1" directory
doimage2 = True # calwebb_image2; files saved in "stage2_img" directory
doimage3 = True # calwebb_image3; files saved in "stage3_img" directory
dospec2 = True # calwebb_spec2; files saved in "stage2_spec" directory
dospec3 = True # calwebb_spec3; files saved in "stage3_spec" directory
Set CRDS context and server#
Before importing CRDS
and JWST
modules, we need to configure our environment. This includes defining a CRDS cache directory in which to keep the reference files that will be used by the calibration pipeline. The pipeline will fetch and download the needed reference files to this directory.
If the root directory for the local CRDS cache directory has not been set already, it will be set to create one in the home directory.
# ------------------------Set CRDS context and paths----------------------
# Set CRDS context (if overriding to use a specific version of reference
# files; leave commented out to use latest reference files by default)
# %env CRDS_CONTEXT jwst_1413.pmap
# Check whether the local CRDS cache directory has been set.
# If not, set it to the user home directory
if (os.getenv('CRDS_PATH') is None):
os.environ['CRDS_PATH'] = os.path.join(os.path.expanduser('~'), 'crds')
# Check whether the CRDS server URL has been set. If not, set it.
if (os.getenv('CRDS_SERVER_URL') is None):
os.environ['CRDS_SERVER_URL'] = 'https://jwst-crds.stsci.edu'
# Echo CRDS path in use
print(f"CRDS local filepath: {os.environ['CRDS_PATH']}")
print(f"CRDS file server: {os.environ['CRDS_SERVER_URL']}")
CRDS local filepath: /home/runner/crds
CRDS file server: https://jwst-crds.stsci.edu
2. Package Imports#
# Basic system utilities for interacting with files
# ----------------------General Imports------------------------------------
import glob
import time
from pathlib import Path
# Data calculations and manipulation
import numpy as np
import pandas as pd
import json
from collections import defaultdict
# -----------------------Plotting Imports----------------------------------
from matplotlib import pyplot as plt
# interactive plots within the notebook
%matplotlib inline
# -----------------------Astronomy Imports--------------------------------
# ASCII files, and downloading demo files
from astroquery.mast import Observations
from astroquery.mast.utils import remove_duplicate_products
# Astropy routines for visualizing detected sources:
import astropy.units as u
from astropy.io import fits
from astropy.table import Table
from astropy.coordinates import SkyCoord
# for JWST calibration pipeline
import jwst
import crds
from jwst.pipeline import Detector1Pipeline
from jwst.pipeline import Image2Pipeline
from jwst.pipeline import Image3Pipeline
from jwst.pipeline import Spec2Pipeline
from jwst.pipeline import Spec3Pipeline
# JWST pipeline utilities
from jwst import datamodels
from jwst.associations import asn_from_list # Tools for creating association files
from jwst.associations.lib.rules_level2_base import DMSLevel2bBase # Definition of a Lvl2 association file
from jwst.associations.lib.rules_level3_base import DMS_Level3_Base # Definition of a Lvl3 association file
# Echo pipeline version and CRDS context in use
print(f"JWST Calibration Pipeline Version: {jwst.__version__}")
print(f"Using CRDS Context: {crds.get_context_name('jwst')}")
JWST Calibration Pipeline Version: 1.19.1
CRDS - INFO - Calibration SW Found: jwst 1.19.1 (/usr/share/miniconda/lib/python3.13/site-packages/jwst-1.19.1.dist-info)
Using CRDS Context: jwst_1413.pmap
Define convenience functions#
These functions are used within the notebook and assist with plotting, finding the appropriate extension for a specific source in spec2 cal data, and verifying what steps and reference files were used for a provided file. These may be useful for your own analysis outside of this notebook, but are written for this notebook in particular.
Plotting Spec2 & Spec3 convenience functions#
# this function will be used to plot the i2d image for a specific source as well as the catalog x/y centroid for that source
def plot_i2d_plus_source(catname, source_id, ax):
# open the i2d & catalog and find the associated source number
i2dname = catname.replace('cat.ecsv', 'i2d.fits')
cat = Table.read(catname)
cat_line = cat[cat['label'] == source_id]
# plot the image
with fits.open(i2dname) as i2d:
display_vals = [np.nanpercentile(i2d[1].data, 1), np.nanpercentile(i2d[1].data, 98)]
ax_i2d.imshow(i2d[1].data, vmin=display_vals[0], vmax=display_vals[1], origin='lower', cmap='gist_gray_r')
# plot up the source catalog
xcentroid = cat_line['xcentroid'][0]
ycentroid = cat_line['ycentroid'][0]
ax.set_xlim(xcentroid-20, xcentroid+20)
ax.set_ylim(ycentroid-20, ycentroid+20)
if cat_line['is_extended'] is True:
cat_color = 'deepskyblue'
cat_marker = 'o'
else:
cat_color = 'deeppink'
cat_marker = 's'
ax.scatter(xcentroid, ycentroid, s=20, facecolors='None', edgecolors=cat_color, marker=cat_marker, alpha=0.9)
ax.annotate(source_id,
(xcentroid+0.5, ycentroid+0.5),
fontsize=10,
color=cat_color)
return ax
# this function is used to plot the wavelength vs. flux values for x1d & c1d spectra for a specific source
def plot_spectrum(specfile, source_fluxes, ax, image3_dir, ext=1, legend=True):
# trimming off some of the edges where the flux is unreliable
plot_limits = {'F090W': {'wavemin': 0.85, 'wavemax': 0.9},
'F115W': {'wavemin': 0.9, 'wavemax': 1.25},
'F150W': {'wavemin': 1.35, 'wavemax': 1.65},
'F200W': {'wavemin': 1.75, 'wavemax': 2.2},
'F140M': {'wavemin': 1.25, 'wavemax': 1.5},
'F158M': {'wavemin': 1.45, 'wavemax': 1.65},
}
with fits.open(specfile) as spec:
# pull out relevant keywords
grism = spec[0].header['FILTER']
pupil = spec[0].header['PUPIL']
catname = os.path.join(image3_dir, spec[0].header['SCATFILE'])
try:
label = f"{grism} dither {spec[0].header['DIT_PATT']}"
except KeyError:
label = f"{grism}" # there is no dither in the c1d files
# find where in the file the source data are
wh_spec_source = np.where(spec[ext].data['SOURCE_ID'] == source_id)[0]
# if the source isn't in the file, then return a blank axis
if not len(wh_spec_source):
print(f'Source {source_id} not found in {specfile}')
return ax, catname, source_fluxes, grism
# grab the wavelength & flux data and trim off the edges for visalization purposes
wave = spec[ext].data['WAVELENGTH'][wh_spec_source]
flux = spec[ext].data['FLUX'][wh_spec_source]
wavemin = plot_limits[pupil]['wavemin']
wavemax = plot_limits[pupil]['wavemax']
wh_wave = np.where((wave >= wavemin) & (wave <= wavemax)) # cutting off the edges
wave = wave[wh_wave]
flux = flux[wh_wave]
if len(flux[np.isnan(flux)]) == len(flux):
print(f'There are no valid pixels for {os.path.basename(specfile)} source {source_id} {grism}. Source likely on edge of detector; not plotting')
else:
source_fluxes.extend(flux) # keep the flux to set the limits of the plot later
if grism == 'GR150R':
linestyle = '-'
else:
linestyle = '--'
ax.plot(wave, flux, label=label, ls=linestyle)
if legend:
ax.legend(bbox_to_anchor=(1, 1))
return ax, catname, source_fluxes, grism
# this function is used to plot the spec2 cal files for a specific source
def plot_spec2_cal(x1dfile, source_id, ax, transpose=False):
cal_file = x1dfile.replace('x1d.fits', 'cal.fits')
with fits.open(cal_file) as cal_hdu:
wh_cal = find_source_ext(cal_hdu, source_id)
# if the source isn't in the file, then return a blank axis
if wh_cal == -999:
print(f'Source {source_id} not found in {cal_file}')
return ax
if transpose is True:
# we flip the GR150R data so that we can look at the two cal images along the same dispersion axis
cal_data = np.transpose(cal_hdu[wh_cal].data)
else:
cal_data = cal_hdu[wh_cal].data
cal_display_vals = [np.nanpercentile(cal_data, 5), np.nanpercentile(cal_data, 90)]
ax.imshow(cal_data, vmin=cal_display_vals[0], vmax=cal_display_vals[1], origin='lower', aspect='auto')
# the dispersion is in the -x direction, so flip the axis for ease in visualization
ax.invert_xaxis()
return ax
Other convienence functions#
# a function to use to find the extension the source is located in the cal files
def find_source_ext(cal_hdu, source_id, info=True):
# look for cal extension, too, but only in the SCI extension;
# fill in with a source ID of -999 for all other extensions to get the right extension value
cal_source_ids = np.array([cal_hdu[ext].header['SOURCEID'] if cal_hdu[ext].header['EXTNAME'] == 'SCI'
else -999 for ext in range(len(cal_hdu))[1:-1]])
try:
wh_cal = np.where(cal_source_ids == source_id)[0][0] + 1 # need to add 1 for the primary header
except IndexError:
# this source doesn't exist
return -999
if info:
print(f"Extension {wh_cal} in {cal_hdu[0].header['FILENAME']} contains the data for source {source_id} from our catalog")
return wh_cal
# a function to quickly see all of the steps that were run on a specified file
def check_steps_run(filename):
# Read in file as datamodel
dm = datamodels.open(filename)
# Check which steps were run
print(f"{dm.meta.filename} - {dm.meta.exposure.type}")
for step, status in dm.meta.cal_step.instance.items():
print(f"{step}: {status}")
print()
# a function to quickly see all of the reference files that were used on a specified file
def check_ref_file_used(filename):
# Read in file as datamodel
dm = datamodels.open(filename)
# Check which reference files were used
print(f"{dm.meta.filename} - {dm.meta.exposure.type}")
for step, status in dm.meta.ref_file.instance.items():
print(f"{step}: {status}")
print()
# a function to find the closest source_id for a given RA/Dec
def find_closest_source_id(ra, dec, catalog_name):
# open the source catalog
cat = Table.read(catalog_name)
# set up a skycoord object for the given RA/Dec
c = SkyCoord(ra=ra*u.degree, dec=dec*u.degree)
# Find the closest match to those coordinates in the source catalog
nearest_id, distance_2d, distance_3d = c.match_to_catalog_sky(cat['sky_centroid'])
return cat['label'][nearest_id]
# Start a timer to keep track of runtime
time0 = time.perf_counter()
3. Directory Setup#
Set up detailed paths to input/output stages here.
# Define output subdirectories to keep science data products organized
uncal_dir = os.path.join(sci_dir, 'uncal') # Uncalibrated pipeline inputs should be here
det1_dir = os.path.join(sci_dir, 'stage1') # calwebb_detector1 pipeline outputs will go here
image2_dir = os.path.join(sci_dir, 'stage2_img') # calwebb_image2 pipeline outputs will go here
image3_dir = os.path.join(sci_dir, 'stage3_img') # calwebb_image3 pipeline outputs will go here
spec2_dir = os.path.join(sci_dir, 'stage2_spec') # calwebb_spec2 pipeline outputs will go here
spec3_dir = os.path.join(sci_dir, 'stage3_spec') # calwebb_spec3 pipeline outputs will go here
# We need to check that the desired output directories exist, and if not create them
for cal_dir in [sci_dir, uncal_dir, det1_dir, image2_dir, image3_dir, spec2_dir, spec3_dir]:
os.makedirs(cal_dir, exist_ok=True)
4. Demo Mode Setup (Data Download)#
If running in demonstration mode, set up the program information to
retrieve the uncalibrated data automatically from MAST using
astroquery.
MAST allows for flexibility of searching by the proposal ID and the
observation ID instead of just filenames.
For illustrative purposes, we focus on data taken through the NIRISS F200W filter and start with uncalibrated data products, or _uncal
files. To search for additional filters, update the filters
field in query_criteria
to include the additional filter, i.e. [‘F200W’, ‘F115W’]. Note that if the observation does not have a level 3 product for any reason, the obs_id
field in query_criteria
will need to be changed to search on the string of the format “jw*+program+sci_observtn+*”.
Information about the JWST file naming conventions can be found at: https://jwst-pipeline.readthedocs.io/en/latest/jwst/data_products/file_naming.html
Note – if for some reason this section does not work, this is equivalet to downloading the _uncal.fits
files from this MAST search:
https://mast.stsci.edu/search/ui/#/jwst/results?instruments=NIRISS&program_id=2079&obs_id=004&custom_col_val_0=1b&custom_col_sel_1=niriss_pupil&custom_col_val_1=F200W&
if dodownload:
if demo_mode:
# Obtain a list of observation IDs for the specified demo program
sci_obs_id_table = Observations.query_criteria(instrument_name=["NIRISS/IMAGE", "NIRISS/WFSS"],
provenance_name=["CALJWST"], # Executed observations
filters=['F200W'], # Data for Specific Filter
obs_id=['jw*' + program + '-o' + sci_observtn + '*']
)
else:
sci_obs_id_table = Observations.query_criteria(instrument_name=["NIRISS/IMAGE", "NIRISS/WFSS"],
provenance_name=["CALJWST"], # Executed observations
obs_id=['jw*' + program + '-o' + sci_observtn + '*']
)
# Turn the list of visits into a list of uncalibrated data files
if dodownload:
# Define types of files to select
file_dict = {'uncal': {'product_type': 'SCIENCE',
'productSubGroupDescription': 'UNCAL',
'calib_level': [1]}}
batch_size = 5 # 5 files at a time maximizes the download speed.
# This is necessary when there are many exposures in a program
# split up our list of files into batches according to our batch size.
obs_batches = [sci_obs_id_table[i:i+batch_size] for i in range(0, len(sci_obs_id_table), batch_size)]
# Science files
sci_files_to_download = []
# Loop over visits identifying uncalibrated files that are associated
# with them
for exposure in (obs_batches):
products = Observations.get_product_list(exposure)
for filetype, query_dict in file_dict.items():
filtered_products = Observations.filter_products(products, productType=query_dict['product_type'],
productSubGroupDescription=query_dict['productSubGroupDescription'],
calib_level=query_dict['calib_level'])
sci_files_to_download.extend(filtered_products['dataURI'])
sci_files_to_download = sorted(sci_files_to_download)
sci_files_to_download = remove_duplicate_products(sci_files_to_download, 'filename')
print(f"Science files selected for downloading: {len(sci_files_to_download)}")
INFO: 606 of 620 products were duplicates. Only returning 14 unique product(s). [astroquery.mast.utils]
Science files selected for downloading: 14
Download all the uncal files and place them into the appropriate directories.
if dodownload:
for filename in sci_files_to_download:
sci_manifest = Observations.download_file(filename,
local_path=os.path.join(uncal_dir, Path(filename).name))
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:JWST/product/jw02079004003_02101_00001_nis_uncal.fits to /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/uncal/jw02079004003_02101_00001_nis_uncal.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:JWST/product/jw02079004003_03101_00001_nis_uncal.fits to /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/uncal/jw02079004003_03101_00001_nis_uncal.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:JWST/product/jw02079004003_03101_00002_nis_uncal.fits to /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/uncal/jw02079004003_03101_00002_nis_uncal.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:JWST/product/jw02079004003_03101_00003_nis_uncal.fits to /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/uncal/jw02079004003_03101_00003_nis_uncal.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:JWST/product/jw02079004003_04101_00001_nis_uncal.fits to /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/uncal/jw02079004003_04101_00001_nis_uncal.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:JWST/product/jw02079004003_04101_00002_nis_uncal.fits to /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/uncal/jw02079004003_04101_00002_nis_uncal.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:JWST/product/jw02079004003_04101_00003_nis_uncal.fits to /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/uncal/jw02079004003_04101_00003_nis_uncal.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:JWST/product/jw02079004003_04101_00004_nis_uncal.fits to /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/uncal/jw02079004003_04101_00004_nis_uncal.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:JWST/product/jw02079004003_05101_00001_nis_uncal.fits to /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/uncal/jw02079004003_05101_00001_nis_uncal.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:JWST/product/jw02079004003_05101_00002_nis_uncal.fits to /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/uncal/jw02079004003_05101_00002_nis_uncal.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:JWST/product/jw02079004003_05101_00003_nis_uncal.fits to /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/uncal/jw02079004003_05101_00003_nis_uncal.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:JWST/product/jw02079004003_06101_00001_nis_uncal.fits to /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/uncal/jw02079004003_06101_00001_nis_uncal.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:JWST/product/jw02079004003_06101_00002_nis_uncal.fits to /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/uncal/jw02079004003_06101_00002_nis_uncal.fits ...
[Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:JWST/product/jw02079004003_06101_00003_nis_uncal.fits to /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/uncal/jw02079004003_06101_00003_nis_uncal.fits ...
[Done]
# Print out the time benchmark
time_download_end = time.perf_counter()
print(f"Runtime for downloading data: {(time_download_end - time0)/60:0.0f} minutes")
Runtime for downloading data: 164 minutes
5. Detector1 Pipeline#
In this section we run the *_uncal.fits
files through the Detector1 stage of the pipeline to apply detector level calibrations and create a countrate data product where slopes are fit to the integration ramps. These *_rate.fits
products are 2D (nrows x ncols), averaged over all integrations. 3D countrate data products (*_rateints.fits
) are also created (nintegrations x nrows x ncols) which have the fitted ramp slopes for each integration.
If there are no modifications to the steps at this stage needed, you can also save time by downloading these *_rate.fits
files directly from MAST and starting at stage2. However, it is best to ensure that you are using the same pipeline version as MAST which can be checked in the CAL_VER
header keyword.
The parameters in each of the Detector1 steps can be modified from the default values, including overwriting reference files that are used. This dictionary of the modified parameters for each of the steps is then fed into the steps
parameter of the Detector1Pipeline
call.
time_det1_start = time.perf_counter()
# Set up a dictionary to define how the Detector1 pipeline should be configured
# this sets up any entry to det1dict to be a dictionary itself
det1dict = defaultdict(dict)
# ---------------------------Override reference files---------------------------
# Example overrides for various reference files
# Files should be in the base local directory or provide full path
# det1dict['dq_init']['override_mask'] = 'myfile.fits' # Bad pixel mask
# det1dict['saturation']['override_saturation'] = 'myfile.fits' # Saturation
# det1dict['linearity']['override_linearity'] = 'myfile.fits' # Linearity
# det1dict['dark_current']['override_dark'] = 'myfile.fits' # Dark current subtraction
# det1dict['jump']['override_gain'] = 'myfile.fits' # Gain used by jump step
# det1dict['ramp_fit']['override_gain'] = 'myfile.fits' # Gain used by ramp fitting step
# det1dict['jump']['override_readnoise'] = 'myfile.fits' # Read noise used by jump step
# det1dict['ramp_fit']['override_readnoise'] = 'myfile.fits' # Read noise used by ramp fitting step
# -----------------------------Set step parameters------------------------------
# Example overrides for whether or not certain steps should be skipped;
# det1dict['persistence']['skip'] = True # skipping the persistence step
# Example of turning on multi-core processing for the jump step (a single core is used by default).
# Choose what fraction of cores to use (quarter, half, all, or the default=1); This will speed up the calibration time
# det1dict['jump']['maximum_cores'] = 'half'
# Example of altering parameters to optimize removal of snowball residuals
# det1dict['jump']['expand_large_events'] = True
# det1dict['charge_migration']['signal_threshold'] = X
uncal_files = sorted(glob.glob(os.path.join(uncal_dir, '*_uncal.fits')))
# Run Detector1 stage of pipeline, specifying:
# output directory to save *_rateints.fits files
# save_results flag set to True so the files are saved locally
if dodet1:
for uncal in uncal_files:
rate_result = Detector1Pipeline.call(uncal, output_dir=det1_dir, steps=det1dict, save_results=True)
else:
print('Skipping Detector1 processing')
2025-09-13 15:32:24,462 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_system_datalvl_0002.rmap 694 bytes (1 / 206 files) (0 / 754.6 K bytes)
2025-09-13 15:32:24,706 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_system_calver_0054.rmap 5.5 K bytes (2 / 206 files) (694 / 754.6 K bytes)
2025-09-13 15:32:24,951 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_system_0053.imap 385 bytes (3 / 206 files) (6.2 K / 754.6 K bytes)
2025-09-13 15:32:25,197 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_nirspec_wavelengthrange_0024.rmap 1.4 K bytes (4 / 206 files) (6.6 K / 754.6 K bytes)
2025-09-13 15:32:25,443 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_nirspec_wavecorr_0005.rmap 884 bytes (5 / 206 files) (8.0 K / 754.6 K bytes)
2025-09-13 15:32:25,692 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_nirspec_superbias_0081.rmap 36.1 K bytes (6 / 206 files) (8.8 K / 754.6 K bytes)
2025-09-13 15:32:26,011 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_nirspec_sirskernel_0002.rmap 704 bytes (7 / 206 files) (44.9 K / 754.6 K bytes)
2025-09-13 15:32:26,264 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_nirspec_sflat_0027.rmap 20.6 K bytes (8 / 206 files) (45.6 K / 754.6 K bytes)
2025-09-13 15:32:26,606 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_nirspec_saturation_0018.rmap 2.0 K bytes (9 / 206 files) (66.2 K / 754.6 K bytes)
2025-09-13 15:32:26,849 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_nirspec_refpix_0015.rmap 1.6 K bytes (10 / 206 files) (68.2 K / 754.6 K bytes)
2025-09-13 15:32:27,115 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_nirspec_readnoise_0025.rmap 2.6 K bytes (11 / 206 files) (69.8 K / 754.6 K bytes)
2025-09-13 15:32:27,378 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_nirspec_pictureframe_0001.rmap 675 bytes (12 / 206 files) (72.4 K / 754.6 K bytes)
2025-09-13 15:32:27,626 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_nirspec_photom_0013.rmap 958 bytes (13 / 206 files) (73.1 K / 754.6 K bytes)
2025-09-13 15:32:27,867 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_nirspec_pathloss_0008.rmap 1.2 K bytes (14 / 206 files) (74.0 K / 754.6 K bytes)
2025-09-13 15:32:28,111 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_nirspec_pars-whitelightstep_0001.rmap 777 bytes (15 / 206 files) (75.2 K / 754.6 K bytes)
2025-09-13 15:32:28,360 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_nirspec_pars-spec2pipeline_0013.rmap 2.1 K bytes (16 / 206 files) (76.0 K / 754.6 K bytes)
2025-09-13 15:32:28,604 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_nirspec_pars-resamplespecstep_0002.rmap 709 bytes (17 / 206 files) (78.1 K / 754.6 K bytes)
2025-09-13 15:32:28,842 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_nirspec_pars-refpixstep_0002.rmap 831 bytes (18 / 206 files) (78.8 K / 754.6 K bytes)
2025-09-13 15:32:29,094 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_nirspec_pars-outlierdetectionstep_0005.rmap 1.1 K bytes (19 / 206 files) (79.6 K / 754.6 K bytes)
2025-09-13 15:32:29,343 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_nirspec_pars-jumpstep_0005.rmap 810 bytes (20 / 206 files) (80.8 K / 754.6 K bytes)
2025-09-13 15:32:29,590 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_nirspec_pars-image2pipeline_0008.rmap 1.0 K bytes (21 / 206 files) (81.6 K / 754.6 K bytes)
2025-09-13 15:32:29,830 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_nirspec_pars-detector1pipeline_0003.rmap 1.1 K bytes (22 / 206 files) (82.6 K / 754.6 K bytes)
2025-09-13 15:32:30,070 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_nirspec_pars-darkpipeline_0003.rmap 872 bytes (23 / 206 files) (83.7 K / 754.6 K bytes)
2025-09-13 15:32:30,312 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_nirspec_pars-darkcurrentstep_0003.rmap 1.8 K bytes (24 / 206 files) (84.5 K / 754.6 K bytes)
2025-09-13 15:32:30,557 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_nirspec_ote_0030.rmap 1.3 K bytes (25 / 206 files) (86.3 K / 754.6 K bytes)
2025-09-13 15:32:30,799 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_nirspec_msaoper_0016.rmap 1.5 K bytes (26 / 206 files) (87.6 K / 754.6 K bytes)
2025-09-13 15:32:31,048 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_nirspec_msa_0027.rmap 1.3 K bytes (27 / 206 files) (89.1 K / 754.6 K bytes)
2025-09-13 15:32:31,293 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_nirspec_mask_0043.rmap 3.5 K bytes (28 / 206 files) (90.4 K / 754.6 K bytes)
2025-09-13 15:32:31,538 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_nirspec_linearity_0017.rmap 1.6 K bytes (29 / 206 files) (93.9 K / 754.6 K bytes)
2025-09-13 15:32:31,789 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_nirspec_ipc_0006.rmap 876 bytes (30 / 206 files) (95.5 K / 754.6 K bytes)
2025-09-13 15:32:32,029 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_nirspec_ifuslicer_0017.rmap 1.5 K bytes (31 / 206 files) (96.4 K / 754.6 K bytes)
2025-09-13 15:32:32,271 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_nirspec_ifupost_0019.rmap 1.5 K bytes (32 / 206 files) (97.9 K / 754.6 K bytes)
2025-09-13 15:32:32,510 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_nirspec_ifufore_0017.rmap 1.5 K bytes (33 / 206 files) (99.4 K / 754.6 K bytes)
2025-09-13 15:32:32,755 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_nirspec_gain_0023.rmap 1.8 K bytes (34 / 206 files) (100.9 K / 754.6 K bytes)
2025-09-13 15:32:32,995 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_nirspec_fpa_0028.rmap 1.3 K bytes (35 / 206 files) (102.7 K / 754.6 K bytes)
2025-09-13 15:32:33,239 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_nirspec_fore_0026.rmap 5.0 K bytes (36 / 206 files) (103.9 K / 754.6 K bytes)
2025-09-13 15:32:33,490 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_nirspec_flat_0015.rmap 3.8 K bytes (37 / 206 files) (108.9 K / 754.6 K bytes)
2025-09-13 15:32:33,735 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_nirspec_fflat_0027.rmap 7.2 K bytes (38 / 206 files) (112.7 K / 754.6 K bytes)
2025-09-13 15:32:33,983 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_nirspec_extract1d_0018.rmap 2.3 K bytes (39 / 206 files) (119.9 K / 754.6 K bytes)
2025-09-13 15:32:34,226 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_nirspec_disperser_0028.rmap 5.7 K bytes (40 / 206 files) (122.2 K / 754.6 K bytes)
2025-09-13 15:32:34,468 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_nirspec_dflat_0007.rmap 1.1 K bytes (41 / 206 files) (127.9 K / 754.6 K bytes)
2025-09-13 15:32:34,711 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_nirspec_dark_0076.rmap 34.3 K bytes (42 / 206 files) (129.0 K / 754.6 K bytes)
2025-09-13 15:32:35,035 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_nirspec_cubepar_0015.rmap 966 bytes (43 / 206 files) (163.4 K / 754.6 K bytes)
2025-09-13 15:32:35,277 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_nirspec_collimator_0026.rmap 1.3 K bytes (44 / 206 files) (164.3 K / 754.6 K bytes)
2025-09-13 15:32:35,519 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_nirspec_camera_0026.rmap 1.3 K bytes (45 / 206 files) (165.7 K / 754.6 K bytes)
2025-09-13 15:32:35,765 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_nirspec_barshadow_0007.rmap 1.8 K bytes (46 / 206 files) (166.9 K / 754.6 K bytes)
2025-09-13 15:32:36,011 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_nirspec_area_0018.rmap 6.3 K bytes (47 / 206 files) (168.7 K / 754.6 K bytes)
2025-09-13 15:32:36,258 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_nirspec_apcorr_0009.rmap 5.6 K bytes (48 / 206 files) (175.0 K / 754.6 K bytes)
2025-09-13 15:32:36,504 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_nirspec_0406.imap 5.8 K bytes (49 / 206 files) (180.6 K / 754.6 K bytes)
2025-09-13 15:32:36,746 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_niriss_wfssbkg_0011.rmap 3.1 K bytes (50 / 206 files) (186.4 K / 754.6 K bytes)
2025-09-13 15:32:36,989 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_niriss_wavelengthrange_0008.rmap 897 bytes (51 / 206 files) (189.5 K / 754.6 K bytes)
2025-09-13 15:32:37,233 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_niriss_trappars_0004.rmap 753 bytes (52 / 206 files) (190.4 K / 754.6 K bytes)
2025-09-13 15:32:37,476 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_niriss_trapdensity_0005.rmap 705 bytes (53 / 206 files) (191.2 K / 754.6 K bytes)
2025-09-13 15:32:37,719 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_niriss_throughput_0005.rmap 1.3 K bytes (54 / 206 files) (191.9 K / 754.6 K bytes)
2025-09-13 15:32:37,966 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_niriss_superbias_0031.rmap 7.7 K bytes (55 / 206 files) (193.1 K / 754.6 K bytes)
2025-09-13 15:32:38,210 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_niriss_specwcs_0015.rmap 3.1 K bytes (56 / 206 files) (200.8 K / 754.6 K bytes)
2025-09-13 15:32:38,453 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_niriss_specprofile_0008.rmap 2.4 K bytes (57 / 206 files) (203.9 K / 754.6 K bytes)
2025-09-13 15:32:38,708 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_niriss_speckernel_0006.rmap 1.0 K bytes (58 / 206 files) (206.3 K / 754.6 K bytes)
2025-09-13 15:32:38,956 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_niriss_sirskernel_0002.rmap 700 bytes (59 / 206 files) (207.4 K / 754.6 K bytes)
2025-09-13 15:32:39,201 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_niriss_saturation_0015.rmap 829 bytes (60 / 206 files) (208.1 K / 754.6 K bytes)
2025-09-13 15:32:39,440 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_niriss_readnoise_0011.rmap 987 bytes (61 / 206 files) (208.9 K / 754.6 K bytes)
2025-09-13 15:32:39,680 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_niriss_photom_0036.rmap 1.3 K bytes (62 / 206 files) (209.9 K / 754.6 K bytes)
2025-09-13 15:32:39,920 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_niriss_persat_0007.rmap 674 bytes (63 / 206 files) (211.1 K / 754.6 K bytes)
2025-09-13 15:32:40,162 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_niriss_pathloss_0003.rmap 758 bytes (64 / 206 files) (211.8 K / 754.6 K bytes)
2025-09-13 15:32:40,402 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_niriss_pastasoss_0004.rmap 818 bytes (65 / 206 files) (212.6 K / 754.6 K bytes)
2025-09-13 15:32:40,647 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_niriss_pars-undersamplecorrectionstep_0001.rmap 904 bytes (66 / 206 files) (213.4 K / 754.6 K bytes)
2025-09-13 15:32:40,890 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_niriss_pars-tweakregstep_0012.rmap 3.1 K bytes (67 / 206 files) (214.3 K / 754.6 K bytes)
2025-09-13 15:32:41,135 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_niriss_pars-spec2pipeline_0009.rmap 1.2 K bytes (68 / 206 files) (217.4 K / 754.6 K bytes)
2025-09-13 15:32:41,376 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_niriss_pars-sourcecatalogstep_0002.rmap 2.3 K bytes (69 / 206 files) (218.6 K / 754.6 K bytes)
2025-09-13 15:32:41,617 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_niriss_pars-resamplestep_0002.rmap 687 bytes (70 / 206 files) (221.0 K / 754.6 K bytes)
2025-09-13 15:32:41,862 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_niriss_pars-outlierdetectionstep_0004.rmap 2.7 K bytes (71 / 206 files) (221.6 K / 754.6 K bytes)
2025-09-13 15:32:42,106 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_niriss_pars-jumpstep_0007.rmap 6.4 K bytes (72 / 206 files) (224.3 K / 754.6 K bytes)
2025-09-13 15:32:42,349 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_niriss_pars-image2pipeline_0005.rmap 1.0 K bytes (73 / 206 files) (230.7 K / 754.6 K bytes)
2025-09-13 15:32:42,588 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_niriss_pars-detector1pipeline_0002.rmap 1.0 K bytes (74 / 206 files) (231.7 K / 754.6 K bytes)
2025-09-13 15:32:42,829 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_niriss_pars-darkpipeline_0002.rmap 868 bytes (75 / 206 files) (232.7 K / 754.6 K bytes)
2025-09-13 15:32:43,069 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_niriss_pars-darkcurrentstep_0001.rmap 591 bytes (76 / 206 files) (233.6 K / 754.6 K bytes)
2025-09-13 15:32:43,308 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_niriss_pars-chargemigrationstep_0005.rmap 5.7 K bytes (77 / 206 files) (234.2 K / 754.6 K bytes)
2025-09-13 15:32:43,549 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_niriss_nrm_0005.rmap 663 bytes (78 / 206 files) (239.9 K / 754.6 K bytes)
2025-09-13 15:32:43,788 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_niriss_mask_0023.rmap 1.4 K bytes (79 / 206 files) (240.5 K / 754.6 K bytes)
2025-09-13 15:32:44,028 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_niriss_linearity_0022.rmap 961 bytes (80 / 206 files) (241.9 K / 754.6 K bytes)
2025-09-13 15:32:44,268 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_niriss_ipc_0007.rmap 651 bytes (81 / 206 files) (242.9 K / 754.6 K bytes)
2025-09-13 15:32:44,518 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_niriss_gain_0011.rmap 797 bytes (82 / 206 files) (243.5 K / 754.6 K bytes)
2025-09-13 15:32:44,757 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_niriss_flat_0023.rmap 5.9 K bytes (83 / 206 files) (244.3 K / 754.6 K bytes)
2025-09-13 15:32:44,997 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_niriss_filteroffset_0010.rmap 853 bytes (84 / 206 files) (250.2 K / 754.6 K bytes)
2025-09-13 15:32:45,242 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_niriss_extract1d_0007.rmap 905 bytes (85 / 206 files) (251.1 K / 754.6 K bytes)
2025-09-13 15:32:45,488 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_niriss_drizpars_0004.rmap 519 bytes (86 / 206 files) (252.0 K / 754.6 K bytes)
2025-09-13 15:32:45,730 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_niriss_distortion_0025.rmap 3.4 K bytes (87 / 206 files) (252.5 K / 754.6 K bytes)
2025-09-13 15:32:45,979 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_niriss_dark_0035.rmap 7.8 K bytes (88 / 206 files) (255.9 K / 754.6 K bytes)
2025-09-13 15:32:46,223 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_niriss_bkg_0005.rmap 3.1 K bytes (89 / 206 files) (263.7 K / 754.6 K bytes)
2025-09-13 15:32:46,465 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_niriss_area_0014.rmap 2.7 K bytes (90 / 206 files) (266.8 K / 754.6 K bytes)
2025-09-13 15:32:46,705 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_niriss_apcorr_0010.rmap 4.3 K bytes (91 / 206 files) (269.5 K / 754.6 K bytes)
2025-09-13 15:32:46,946 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_niriss_abvegaoffset_0004.rmap 1.4 K bytes (92 / 206 files) (273.8 K / 754.6 K bytes)
2025-09-13 15:32:47,186 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_niriss_0283.imap 5.8 K bytes (93 / 206 files) (275.1 K / 754.6 K bytes)
2025-09-13 15:32:47,430 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_nircam_wfssbkg_0004.rmap 7.2 K bytes (94 / 206 files) (280.9 K / 754.6 K bytes)
2025-09-13 15:32:47,670 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_nircam_wavelengthrange_0011.rmap 996 bytes (95 / 206 files) (288.1 K / 754.6 K bytes)
2025-09-13 15:32:47,920 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_nircam_tsophot_0003.rmap 896 bytes (96 / 206 files) (289.1 K / 754.6 K bytes)
2025-09-13 15:32:48,159 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_nircam_trappars_0003.rmap 1.6 K bytes (97 / 206 files) (290.0 K / 754.6 K bytes)
2025-09-13 15:32:48,400 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_nircam_trapdensity_0003.rmap 1.6 K bytes (98 / 206 files) (291.6 K / 754.6 K bytes)
2025-09-13 15:32:48,640 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_nircam_superbias_0020.rmap 19.6 K bytes (99 / 206 files) (293.2 K / 754.6 K bytes)
2025-09-13 15:32:48,957 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_nircam_specwcs_0024.rmap 8.0 K bytes (100 / 206 files) (312.8 K / 754.6 K bytes)
2025-09-13 15:32:49,212 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_nircam_sirskernel_0003.rmap 671 bytes (101 / 206 files) (320.8 K / 754.6 K bytes)
2025-09-13 15:32:49,461 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_nircam_saturation_0011.rmap 2.8 K bytes (102 / 206 files) (321.5 K / 754.6 K bytes)
2025-09-13 15:32:49,700 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_nircam_readnoise_0027.rmap 26.6 K bytes (103 / 206 files) (324.3 K / 754.6 K bytes)
2025-09-13 15:32:50,019 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_nircam_psfmask_0008.rmap 28.4 K bytes (104 / 206 files) (350.9 K / 754.6 K bytes)
2025-09-13 15:32:50,335 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_nircam_photom_0028.rmap 3.4 K bytes (105 / 206 files) (379.2 K / 754.6 K bytes)
2025-09-13 15:32:50,580 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_nircam_persat_0005.rmap 1.6 K bytes (106 / 206 files) (382.6 K / 754.6 K bytes)
2025-09-13 15:32:50,846 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_nircam_pars-whitelightstep_0004.rmap 2.0 K bytes (107 / 206 files) (384.2 K / 754.6 K bytes)
2025-09-13 15:32:51,089 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_nircam_pars-tweakregstep_0003.rmap 4.5 K bytes (108 / 206 files) (386.2 K / 754.6 K bytes)
2025-09-13 15:32:51,346 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_nircam_pars-spec2pipeline_0009.rmap 984 bytes (109 / 206 files) (390.6 K / 754.6 K bytes)
2025-09-13 15:32:51,592 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_nircam_pars-sourcecatalogstep_0002.rmap 4.6 K bytes (110 / 206 files) (391.6 K / 754.6 K bytes)
2025-09-13 15:32:51,836 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_nircam_pars-resamplestep_0002.rmap 687 bytes (111 / 206 files) (396.3 K / 754.6 K bytes)
2025-09-13 15:32:52,079 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_nircam_pars-outlierdetectionstep_0003.rmap 940 bytes (112 / 206 files) (397.0 K / 754.6 K bytes)
2025-09-13 15:32:52,322 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_nircam_pars-jumpstep_0005.rmap 806 bytes (113 / 206 files) (397.9 K / 754.6 K bytes)
2025-09-13 15:32:52,564 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_nircam_pars-image2pipeline_0004.rmap 1.1 K bytes (114 / 206 files) (398.7 K / 754.6 K bytes)
2025-09-13 15:32:52,805 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_nircam_pars-detector1pipeline_0006.rmap 1.7 K bytes (115 / 206 files) (399.8 K / 754.6 K bytes)
2025-09-13 15:32:53,051 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_nircam_pars-darkpipeline_0002.rmap 868 bytes (116 / 206 files) (401.6 K / 754.6 K bytes)
2025-09-13 15:32:53,291 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_nircam_pars-darkcurrentstep_0001.rmap 618 bytes (117 / 206 files) (402.4 K / 754.6 K bytes)
2025-09-13 15:32:53,539 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_nircam_mask_0012.rmap 4.1 K bytes (118 / 206 files) (403.1 K / 754.6 K bytes)
2025-09-13 15:32:53,785 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_nircam_linearity_0011.rmap 2.4 K bytes (119 / 206 files) (407.2 K / 754.6 K bytes)
2025-09-13 15:32:54,027 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_nircam_ipc_0003.rmap 2.0 K bytes (120 / 206 files) (409.6 K / 754.6 K bytes)
2025-09-13 15:32:54,266 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_nircam_gain_0016.rmap 2.1 K bytes (121 / 206 files) (411.6 K / 754.6 K bytes)
2025-09-13 15:32:54,512 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_nircam_flat_0028.rmap 51.7 K bytes (122 / 206 files) (413.7 K / 754.6 K bytes)
2025-09-13 15:32:54,906 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_nircam_filteroffset_0004.rmap 1.4 K bytes (123 / 206 files) (465.4 K / 754.6 K bytes)
2025-09-13 15:32:55,145 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_nircam_extract1d_0005.rmap 1.2 K bytes (124 / 206 files) (466.8 K / 754.6 K bytes)
2025-09-13 15:32:55,385 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_nircam_drizpars_0001.rmap 519 bytes (125 / 206 files) (468.0 K / 754.6 K bytes)
2025-09-13 15:32:55,633 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_nircam_distortion_0033.rmap 53.4 K bytes (126 / 206 files) (468.5 K / 754.6 K bytes)
2025-09-13 15:32:56,032 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_nircam_dark_0049.rmap 29.6 K bytes (127 / 206 files) (521.9 K / 754.6 K bytes)
2025-09-13 15:32:56,354 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_nircam_bkg_0002.rmap 7.0 K bytes (128 / 206 files) (551.5 K / 754.6 K bytes)
2025-09-13 15:32:56,601 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_nircam_area_0012.rmap 33.5 K bytes (129 / 206 files) (558.4 K / 754.6 K bytes)
2025-09-13 15:32:56,925 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_nircam_apcorr_0008.rmap 4.3 K bytes (130 / 206 files) (591.9 K / 754.6 K bytes)
2025-09-13 15:32:57,164 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_nircam_abvegaoffset_0003.rmap 1.3 K bytes (131 / 206 files) (596.2 K / 754.6 K bytes)
2025-09-13 15:32:57,413 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_nircam_0326.imap 5.6 K bytes (132 / 206 files) (597.5 K / 754.6 K bytes)
2025-09-13 15:32:57,656 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_miri_wavelengthrange_0027.rmap 929 bytes (133 / 206 files) (603.1 K / 754.6 K bytes)
2025-09-13 15:32:57,900 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_miri_tsophot_0004.rmap 882 bytes (134 / 206 files) (604.1 K / 754.6 K bytes)
2025-09-13 15:32:58,143 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_miri_straymask_0009.rmap 987 bytes (135 / 206 files) (604.9 K / 754.6 K bytes)
2025-09-13 15:32:58,385 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_miri_specwcs_0044.rmap 5.9 K bytes (136 / 206 files) (605.9 K / 754.6 K bytes)
2025-09-13 15:32:58,628 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_miri_saturation_0015.rmap 1.2 K bytes (137 / 206 files) (611.8 K / 754.6 K bytes)
2025-09-13 15:32:58,871 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_miri_rscd_0008.rmap 1.0 K bytes (138 / 206 files) (613.0 K / 754.6 K bytes)
2025-09-13 15:32:59,191 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_miri_resol_0006.rmap 790 bytes (139 / 206 files) (614.0 K / 754.6 K bytes)
2025-09-13 15:32:59,445 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_miri_reset_0026.rmap 3.9 K bytes (140 / 206 files) (614.8 K / 754.6 K bytes)
2025-09-13 15:32:59,686 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_miri_regions_0035.rmap 4.4 K bytes (141 / 206 files) (618.7 K / 754.6 K bytes)
2025-09-13 15:32:59,930 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_miri_readnoise_0023.rmap 1.6 K bytes (142 / 206 files) (623.0 K / 754.6 K bytes)
2025-09-13 15:33:00,171 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_miri_psfmask_0009.rmap 2.1 K bytes (143 / 206 files) (624.7 K / 754.6 K bytes)
2025-09-13 15:33:00,411 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_miri_psf_0007.rmap 2.5 K bytes (144 / 206 files) (626.8 K / 754.6 K bytes)
2025-09-13 15:33:00,662 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_miri_photom_0057.rmap 3.7 K bytes (145 / 206 files) (629.3 K / 754.6 K bytes)
2025-09-13 15:33:00,906 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_miri_pathloss_0005.rmap 866 bytes (146 / 206 files) (633.0 K / 754.6 K bytes)
2025-09-13 15:33:01,146 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_miri_pars-whitelightstep_0003.rmap 912 bytes (147 / 206 files) (633.9 K / 754.6 K bytes)
2025-09-13 15:33:01,390 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_miri_pars-tweakregstep_0003.rmap 1.8 K bytes (148 / 206 files) (634.8 K / 754.6 K bytes)
2025-09-13 15:33:01,630 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_miri_pars-spec3pipeline_0010.rmap 886 bytes (149 / 206 files) (636.7 K / 754.6 K bytes)
2025-09-13 15:33:01,873 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_miri_pars-spec2pipeline_0013.rmap 1.4 K bytes (150 / 206 files) (637.5 K / 754.6 K bytes)
2025-09-13 15:33:02,115 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_miri_pars-sourcecatalogstep_0003.rmap 1.9 K bytes (151 / 206 files) (639.0 K / 754.6 K bytes)
2025-09-13 15:33:02,359 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_miri_pars-resamplestep_0002.rmap 677 bytes (152 / 206 files) (640.9 K / 754.6 K bytes)
2025-09-13 15:33:02,600 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_miri_pars-resamplespecstep_0002.rmap 706 bytes (153 / 206 files) (641.5 K / 754.6 K bytes)
2025-09-13 15:33:02,843 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_miri_pars-outlierdetectionstep_0020.rmap 3.4 K bytes (154 / 206 files) (642.2 K / 754.6 K bytes)
2025-09-13 15:33:03,084 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_miri_pars-jumpstep_0011.rmap 1.6 K bytes (155 / 206 files) (645.6 K / 754.6 K bytes)
2025-09-13 15:33:03,332 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_miri_pars-image2pipeline_0010.rmap 1.1 K bytes (156 / 206 files) (647.2 K / 754.6 K bytes)
2025-09-13 15:33:03,575 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_miri_pars-extract1dstep_0003.rmap 807 bytes (157 / 206 files) (648.3 K / 754.6 K bytes)
2025-09-13 15:33:03,828 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_miri_pars-emicorrstep_0003.rmap 796 bytes (158 / 206 files) (649.1 K / 754.6 K bytes)
2025-09-13 15:33:04,076 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_miri_pars-detector1pipeline_0010.rmap 1.6 K bytes (159 / 206 files) (649.9 K / 754.6 K bytes)
2025-09-13 15:33:04,317 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_miri_pars-darkpipeline_0002.rmap 860 bytes (160 / 206 files) (651.5 K / 754.6 K bytes)
2025-09-13 15:33:04,560 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_miri_pars-darkcurrentstep_0002.rmap 683 bytes (161 / 206 files) (652.3 K / 754.6 K bytes)
2025-09-13 15:33:04,801 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_miri_mrsxartcorr_0002.rmap 2.2 K bytes (162 / 206 files) (653.0 K / 754.6 K bytes)
2025-09-13 15:33:05,049 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_miri_mrsptcorr_0005.rmap 2.0 K bytes (163 / 206 files) (655.2 K / 754.6 K bytes)
2025-09-13 15:33:05,292 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_miri_mask_0028.rmap 4.6 K bytes (164 / 206 files) (657.1 K / 754.6 K bytes)
2025-09-13 15:33:05,535 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_miri_linearity_0018.rmap 2.8 K bytes (165 / 206 files) (661.8 K / 754.6 K bytes)
2025-09-13 15:33:05,779 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_miri_ipc_0008.rmap 700 bytes (166 / 206 files) (664.6 K / 754.6 K bytes)
2025-09-13 15:33:06,024 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_miri_gain_0013.rmap 3.9 K bytes (167 / 206 files) (665.3 K / 754.6 K bytes)
2025-09-13 15:33:06,270 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_miri_fringefreq_0003.rmap 1.4 K bytes (168 / 206 files) (669.2 K / 754.6 K bytes)
2025-09-13 15:33:06,512 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_miri_fringe_0019.rmap 3.9 K bytes (169 / 206 files) (670.7 K / 754.6 K bytes)
2025-09-13 15:33:06,753 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_miri_flat_0067.rmap 15.7 K bytes (170 / 206 files) (674.6 K / 754.6 K bytes)
2025-09-13 15:33:07,064 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_miri_filteroffset_0026.rmap 2.1 K bytes (171 / 206 files) (690.2 K / 754.6 K bytes)
2025-09-13 15:33:07,305 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_miri_extract1d_0020.rmap 1.4 K bytes (172 / 206 files) (692.3 K / 754.6 K bytes)
2025-09-13 15:33:07,549 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_miri_emicorr_0004.rmap 663 bytes (173 / 206 files) (693.7 K / 754.6 K bytes)
2025-09-13 15:33:07,801 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_miri_drizpars_0002.rmap 511 bytes (174 / 206 files) (694.4 K / 754.6 K bytes)
2025-09-13 15:33:08,041 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_miri_distortion_0041.rmap 4.8 K bytes (175 / 206 files) (694.9 K / 754.6 K bytes)
2025-09-13 15:33:08,281 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_miri_dark_0037.rmap 4.4 K bytes (176 / 206 files) (699.6 K / 754.6 K bytes)
2025-09-13 15:33:08,530 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_miri_cubepar_0017.rmap 800 bytes (177 / 206 files) (704.0 K / 754.6 K bytes)
2025-09-13 15:33:08,783 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_miri_area_0015.rmap 866 bytes (178 / 206 files) (704.8 K / 754.6 K bytes)
2025-09-13 15:33:09,027 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_miri_apcorr_0020.rmap 5.0 K bytes (179 / 206 files) (705.7 K / 754.6 K bytes)
2025-09-13 15:33:09,271 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_miri_abvegaoffset_0003.rmap 1.3 K bytes (180 / 206 files) (710.6 K / 754.6 K bytes)
2025-09-13 15:33:09,511 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_miri_0449.imap 5.8 K bytes (181 / 206 files) (711.9 K / 754.6 K bytes)
2025-09-13 15:33:09,755 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_fgs_trappars_0004.rmap 903 bytes (182 / 206 files) (717.7 K / 754.6 K bytes)
2025-09-13 15:33:09,997 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_fgs_trapdensity_0006.rmap 930 bytes (183 / 206 files) (718.6 K / 754.6 K bytes)
2025-09-13 15:33:10,242 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_fgs_superbias_0017.rmap 3.8 K bytes (184 / 206 files) (719.6 K / 754.6 K bytes)
2025-09-13 15:33:10,495 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_fgs_saturation_0009.rmap 779 bytes (185 / 206 files) (723.4 K / 754.6 K bytes)
2025-09-13 15:33:10,734 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_fgs_readnoise_0014.rmap 1.3 K bytes (186 / 206 files) (724.1 K / 754.6 K bytes)
2025-09-13 15:33:10,983 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_fgs_photom_0014.rmap 1.1 K bytes (187 / 206 files) (725.4 K / 754.6 K bytes)
2025-09-13 15:33:11,228 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_fgs_persat_0006.rmap 884 bytes (188 / 206 files) (726.5 K / 754.6 K bytes)
2025-09-13 15:33:11,474 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_fgs_pars-tweakregstep_0002.rmap 850 bytes (189 / 206 files) (727.4 K / 754.6 K bytes)
2025-09-13 15:33:11,714 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_fgs_pars-sourcecatalogstep_0001.rmap 636 bytes (190 / 206 files) (728.2 K / 754.6 K bytes)
2025-09-13 15:33:11,953 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_fgs_pars-outlierdetectionstep_0001.rmap 654 bytes (191 / 206 files) (728.9 K / 754.6 K bytes)
2025-09-13 15:33:12,205 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_fgs_pars-image2pipeline_0005.rmap 974 bytes (192 / 206 files) (729.5 K / 754.6 K bytes)
2025-09-13 15:33:12,453 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_fgs_pars-detector1pipeline_0002.rmap 1.0 K bytes (193 / 206 files) (730.5 K / 754.6 K bytes)
2025-09-13 15:33:12,695 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_fgs_pars-darkpipeline_0002.rmap 856 bytes (194 / 206 files) (731.5 K / 754.6 K bytes)
2025-09-13 15:33:12,934 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_fgs_mask_0023.rmap 1.1 K bytes (195 / 206 files) (732.4 K / 754.6 K bytes)
2025-09-13 15:33:13,174 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_fgs_linearity_0015.rmap 925 bytes (196 / 206 files) (733.5 K / 754.6 K bytes)
2025-09-13 15:33:13,415 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_fgs_ipc_0003.rmap 614 bytes (197 / 206 files) (734.4 K / 754.6 K bytes)
2025-09-13 15:33:13,663 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_fgs_gain_0010.rmap 890 bytes (198 / 206 files) (735.0 K / 754.6 K bytes)
2025-09-13 15:33:13,910 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_fgs_flat_0009.rmap 1.1 K bytes (199 / 206 files) (735.9 K / 754.6 K bytes)
2025-09-13 15:33:14,157 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_fgs_distortion_0011.rmap 1.2 K bytes (200 / 206 files) (737.0 K / 754.6 K bytes)
2025-09-13 15:33:14,397 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_fgs_dark_0017.rmap 4.3 K bytes (201 / 206 files) (738.2 K / 754.6 K bytes)
2025-09-13 15:33:14,639 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_fgs_area_0010.rmap 1.2 K bytes (202 / 206 files) (742.5 K / 754.6 K bytes)
2025-09-13 15:33:14,879 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_fgs_apcorr_0004.rmap 4.0 K bytes (203 / 206 files) (743.7 K / 754.6 K bytes)
2025-09-13 15:33:15,119 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_fgs_abvegaoffset_0002.rmap 1.3 K bytes (204 / 206 files) (747.7 K / 754.6 K bytes)
2025-09-13 15:33:15,364 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_fgs_0123.imap 5.1 K bytes (205 / 206 files) (748.9 K / 754.6 K bytes)
2025-09-13 15:33:15,611 - CRDS - INFO - Fetching /home/runner/crds/mappings/jwst/jwst_1413.pmap 580 bytes (206 / 206 files) (754.0 K / 754.6 K bytes)
2025-09-13 15:33:16,398 - CRDS - ERROR - Error determining best reference for 'pars-darkcurrentstep' = No match found.
2025-09-13 15:33:16,402 - CRDS - INFO - Fetching /home/runner/crds/references/jwst/niriss/jwst_niriss_pars-chargemigrationstep_0016.asdf 1.1 K bytes (1 / 1 files) (0 / 1.1 K bytes)
2025-09-13 15:33:16,647 - stpipe - INFO - PARS-CHARGEMIGRATIONSTEP parameters found: /home/runner/crds/references/jwst/niriss/jwst_niriss_pars-chargemigrationstep_0016.asdf
2025-09-13 15:33:16,660 - CRDS - INFO - Fetching /home/runner/crds/references/jwst/niriss/jwst_niriss_pars-jumpstep_0085.asdf 1.6 K bytes (1 / 1 files) (0 / 1.6 K bytes)
2025-09-13 15:33:16,908 - stpipe - INFO - PARS-JUMPSTEP parameters found: /home/runner/crds/references/jwst/niriss/jwst_niriss_pars-jumpstep_0085.asdf
2025-09-13 15:33:16,919 - CRDS - INFO - Fetching /home/runner/crds/references/jwst/niriss/jwst_niriss_pars-detector1pipeline_0001.asdf 1.1 K bytes (1 / 1 files) (0 / 1.1 K bytes)
2025-09-13 15:33:17,167 - stpipe - INFO - PARS-DETECTOR1PIPELINE parameters found: /home/runner/crds/references/jwst/niriss/jwst_niriss_pars-detector1pipeline_0001.asdf
2025-09-13 15:33:17,182 - stpipe.Detector1Pipeline - INFO - Detector1Pipeline instance created.
2025-09-13 15:33:17,184 - stpipe.Detector1Pipeline.group_scale - INFO - GroupScaleStep instance created.
2025-09-13 15:33:17,184 - stpipe.Detector1Pipeline.dq_init - INFO - DQInitStep instance created.
2025-09-13 15:33:17,185 - stpipe.Detector1Pipeline.emicorr - INFO - EmiCorrStep instance created.
2025-09-13 15:33:17,186 - stpipe.Detector1Pipeline.saturation - INFO - SaturationStep instance created.
2025-09-13 15:33:17,189 - stpipe.Detector1Pipeline.ipc - INFO - IPCStep instance created.
2025-09-13 15:33:17,191 - stpipe.Detector1Pipeline.superbias - INFO - SuperBiasStep instance created.
2025-09-13 15:33:17,192 - stpipe.Detector1Pipeline.refpix - INFO - RefPixStep instance created.
2025-09-13 15:33:17,193 - stpipe.Detector1Pipeline.rscd - INFO - RscdStep instance created.
2025-09-13 15:33:17,193 - stpipe.Detector1Pipeline.firstframe - INFO - FirstFrameStep instance created.
2025-09-13 15:33:17,194 - stpipe.Detector1Pipeline.lastframe - INFO - LastFrameStep instance created.
2025-09-13 15:33:17,195 - stpipe.Detector1Pipeline.linearity - INFO - LinearityStep instance created.
2025-09-13 15:33:17,196 - stpipe.Detector1Pipeline.dark_current - INFO - DarkCurrentStep instance created.
2025-09-13 15:33:17,197 - stpipe.Detector1Pipeline.reset - INFO - ResetStep instance created.
2025-09-13 15:33:17,197 - stpipe.Detector1Pipeline.persistence - INFO - PersistenceStep instance created.
2025-09-13 15:33:17,198 - stpipe.Detector1Pipeline.charge_migration - INFO - ChargeMigrationStep instance created.
2025-09-13 15:33:17,200 - stpipe.Detector1Pipeline.jump - INFO - JumpStep instance created.
2025-09-13 15:33:17,201 - stpipe.Detector1Pipeline.clean_flicker_noise - INFO - CleanFlickerNoiseStep instance created.
2025-09-13 15:33:17,203 - stpipe.Detector1Pipeline.ramp_fit - INFO - RampFitStep instance created.
2025-09-13 15:33:17,204 - stpipe.Detector1Pipeline.gain_scale - INFO - GainScaleStep instance created.
2025-09-13 15:33:17,377 - stpipe.Detector1Pipeline - INFO - Step Detector1Pipeline running with args ('/home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/uncal/jw02079004003_02101_00001_nis_uncal.fits',).
2025-09-13 15:33:17,397 - stpipe.Detector1Pipeline - INFO - Step Detector1Pipeline parameters are:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage1
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: True
skip: False
suffix: None
search_output_file: True
input_dir: ''
save_calibrated_ramp: False
steps:
group_scale:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
dq_init:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
emicorr:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: True
suffix: None
search_output_file: True
input_dir: ''
algorithm: joint
nints_to_phase: None
nbins: None
scale_reference: True
onthefly_corr_freq: None
use_n_cycles: 3
fit_ints_separately: False
user_supplied_reffile: None
save_intermediate_results: False
saturation:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
n_pix_grow_sat: 1
use_readpatt: True
ipc:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: True
suffix: None
search_output_file: True
input_dir: ''
superbias:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
refpix:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
odd_even_columns: True
use_side_ref_pixels: True
side_smoothing_length: 11
side_gain: 1.0
odd_even_rows: True
ovr_corr_mitigation_ftr: 3.0
preserve_irs2_refpix: False
irs2_mean_subtraction: False
refpix_algorithm: median
sigreject: 4.0
gaussmooth: 1.0
halfwidth: 30
rscd:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
firstframe:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
bright_use_group1: False
lastframe:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
linearity:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
dark_current:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
dark_output: None
average_dark_current: None
reset:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
persistence:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
input_trapsfilled: ''
flag_pers_cutoff: 40.0
save_persistence: False
save_trapsfilled: True
modify_input: False
charge_migration:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
signal_threshold: 22314.0
jump:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
rejection_threshold: 4.0
three_group_rejection_threshold: 6.0
four_group_rejection_threshold: 5.0
maximum_cores: '1'
flag_4_neighbors: False
max_jump_to_flag_neighbors: 200.0
min_jump_to_flag_neighbors: 10.0
after_jump_flag_dn1: 1000
after_jump_flag_time1: 90
after_jump_flag_dn2: 0
after_jump_flag_time2: 0
expand_large_events: True
min_sat_area: 5
min_jump_area: 15.0
expand_factor: 1.75
use_ellipses: False
sat_required_snowball: True
min_sat_radius_extend: 5.0
sat_expand: 0
edge_size: 20
mask_snowball_core_next_int: True
snowball_time_masked_next_int: 4000
find_showers: False
max_shower_amplitude: 4.0
extend_snr_threshold: 1.2
extend_min_area: 90
extend_inner_radius: 1.0
extend_outer_radius: 2.6
extend_ellipse_expand_ratio: 1.1
time_masked_after_shower: 15.0
min_diffs_single_pass: 10
max_extended_radius: 100
minimum_groups: 3
minimum_sigclip_groups: 100
only_use_ints: True
clean_flicker_noise:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: True
suffix: None
search_output_file: True
input_dir: ''
fit_method: median
fit_by_channel: False
background_method: median
background_box_size: None
mask_science_regions: False
apply_flat_field: False
n_sigma: 2.0
fit_histogram: False
single_mask: True
user_mask: None
save_mask: False
save_background: False
save_noise: False
ramp_fit:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
algorithm: OLS_C
int_name: ''
save_opt: False
opt_name: ''
suppress_one_group: True
firstgroup: None
lastgroup: None
maximum_cores: '1'
gain_scale:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
2025-09-13 15:33:17,417 - stpipe.Detector1Pipeline - INFO - Prefetching reference files for dataset: 'jw02079004003_02101_00001_nis_uncal.fits' reftypes = ['dark', 'gain', 'linearity', 'mask', 'persat', 'readnoise', 'refpix', 'reset', 'rscd', 'saturation', 'sirskernel', 'superbias', 'trapdensity', 'trappars']
2025-09-13 15:33:17,420 - CRDS - INFO - Fetching /home/runner/crds/references/jwst/niriss/jwst_niriss_dark_0228.fits 1.0 G bytes (1 / 11 files) (0 / 1.4 G bytes)
2025-09-13 15:58:32,800 - CRDS - INFO - Fetching /home/runner/crds/references/jwst/niriss/jwst_niriss_gain_0006.fits 16.8 M bytes (2 / 11 files) (1.0 G / 1.4 G bytes)
2025-09-13 15:59:06,927 - CRDS - INFO - Fetching /home/runner/crds/references/jwst/niriss/jwst_niriss_linearity_0017.fits 205.5 M bytes (3 / 11 files) (1.0 G / 1.4 G bytes)
2025-09-13 16:04:14,119 - CRDS - INFO - Fetching /home/runner/crds/references/jwst/niriss/jwst_niriss_mask_0035.fits 16.8 M bytes (4 / 11 files) (1.2 G / 1.4 G bytes)
2025-09-13 16:04:41,217 - CRDS - INFO - Fetching /home/runner/crds/references/jwst/niriss/jwst_niriss_persat_0004.fits 21.0 M bytes (5 / 11 files) (1.3 G / 1.4 G bytes)
2025-09-13 16:05:07,564 - CRDS - INFO - Fetching /home/runner/crds/references/jwst/niriss/jwst_niriss_readnoise_0005.fits 16.8 M bytes (6 / 11 files) (1.3 G / 1.4 G bytes)
2025-09-13 16:05:38,524 - CRDS - INFO - Fetching /home/runner/crds/references/jwst/niriss/jwst_niriss_saturation_0015.fits 33.6 M bytes (7 / 11 files) (1.3 G / 1.4 G bytes)
2025-09-13 16:06:19,824 - CRDS - INFO - Fetching /home/runner/crds/references/jwst/niriss/jwst_niriss_sirskernel_0001.asdf 67.4 K bytes (8 / 11 files) (1.3 G / 1.4 G bytes)
2025-09-13 16:06:20,225 - CRDS - INFO - Fetching /home/runner/crds/references/jwst/niriss/jwst_niriss_superbias_0238.fits 50.4 M bytes (9 / 11 files) (1.3 G / 1.4 G bytes)
2025-09-13 16:07:36,821 - CRDS - INFO - Fetching /home/runner/crds/references/jwst/niriss/jwst_niriss_trapdensity_0002.fits 21.0 M bytes (10 / 11 files) (1.4 G / 1.4 G bytes)
2025-09-13 16:08:16,613 - CRDS - INFO - Fetching /home/runner/crds/references/jwst/niriss/jwst_niriss_trappars_0002.fits 8.6 K bytes (11 / 11 files) (1.4 G / 1.4 G bytes)
2025-09-13 16:08:16,856 - stpipe.Detector1Pipeline - INFO - Prefetch for DARK reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_dark_0228.fits'.
2025-09-13 16:08:16,857 - stpipe.Detector1Pipeline - INFO - Prefetch for GAIN reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_gain_0006.fits'.
2025-09-13 16:08:16,857 - stpipe.Detector1Pipeline - INFO - Prefetch for LINEARITY reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_linearity_0017.fits'.
2025-09-13 16:08:16,858 - stpipe.Detector1Pipeline - INFO - Prefetch for MASK reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_mask_0035.fits'.
2025-09-13 16:08:16,858 - stpipe.Detector1Pipeline - INFO - Prefetch for PERSAT reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_persat_0004.fits'.
2025-09-13 16:08:16,858 - stpipe.Detector1Pipeline - INFO - Prefetch for READNOISE reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_readnoise_0005.fits'.
2025-09-13 16:08:16,859 - stpipe.Detector1Pipeline - INFO - Prefetch for REFPIX reference file is 'N/A'.
2025-09-13 16:08:16,859 - stpipe.Detector1Pipeline - INFO - Prefetch for RESET reference file is 'N/A'.
2025-09-13 16:08:16,859 - stpipe.Detector1Pipeline - INFO - Prefetch for RSCD reference file is 'N/A'.
2025-09-13 16:08:16,860 - stpipe.Detector1Pipeline - INFO - Prefetch for SATURATION reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_saturation_0015.fits'.
2025-09-13 16:08:16,860 - stpipe.Detector1Pipeline - INFO - Prefetch for SIRSKERNEL reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_sirskernel_0001.asdf'.
2025-09-13 16:08:16,860 - stpipe.Detector1Pipeline - INFO - Prefetch for SUPERBIAS reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_superbias_0238.fits'.
2025-09-13 16:08:16,861 - stpipe.Detector1Pipeline - INFO - Prefetch for TRAPDENSITY reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_trapdensity_0002.fits'.
2025-09-13 16:08:16,861 - stpipe.Detector1Pipeline - INFO - Prefetch for TRAPPARS reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_trappars_0002.fits'.
2025-09-13 16:08:16,862 - jwst.pipeline.calwebb_detector1 - INFO - Starting calwebb_detector1 ...
2025-09-13 16:08:17,166 - stpipe.Detector1Pipeline.group_scale - INFO - Step group_scale running with args (<RampModel(1, 5, 2048, 2048) from jw02079004003_02101_00001_nis_uncal.fits>,).
2025-09-13 16:08:17,173 - stpipe.Detector1Pipeline.group_scale - INFO - NFRAMES and FRMDIVSR are equal; correction not needed
2025-09-13 16:08:17,173 - stpipe.Detector1Pipeline.group_scale - INFO - Step will be skipped
2025-09-13 16:08:17,175 - stpipe.Detector1Pipeline.group_scale - INFO - Step group_scale done
2025-09-13 16:08:17,337 - stpipe.Detector1Pipeline.dq_init - INFO - Step dq_init running with args (<RampModel(1, 5, 2048, 2048) from jw02079004003_02101_00001_nis_uncal.fits>,).
2025-09-13 16:08:17,348 - stpipe.Detector1Pipeline.dq_init - INFO - Using MASK reference file /home/runner/crds/references/jwst/niriss/jwst_niriss_mask_0035.fits
2025-09-13 16:08:17,514 - CRDS - INFO - Calibration SW Found: jwst 1.19.1 (/usr/share/miniconda/lib/python3.13/site-packages/jwst-1.19.1.dist-info)
2025-09-13 16:08:17,762 - stpipe.Detector1Pipeline.dq_init - INFO - Step dq_init done
2025-09-13 16:08:17,929 - stpipe.Detector1Pipeline.saturation - INFO - Step saturation running with args (<RampModel(1, 5, 2048, 2048) from jw02079004003_02101_00001_nis_uncal.fits>,).
2025-09-13 16:08:17,942 - stpipe.Detector1Pipeline.saturation - INFO - Using SATURATION reference file /home/runner/crds/references/jwst/niriss/jwst_niriss_saturation_0015.fits
2025-09-13 16:08:17,942 - stpipe.Detector1Pipeline.saturation - INFO - Using SUPERBIAS reference file /home/runner/crds/references/jwst/niriss/jwst_niriss_superbias_0238.fits
2025-09-13 16:08:17,973 - stdatamodels.dynamicdq - WARNING - Keyword LOWILLUM does not correspond to an existing DQ mnemonic, so will be ignored
2025-09-13 16:08:17,974 - stdatamodels.dynamicdq - WARNING - Keyword LOWRESP does not correspond to an existing DQ mnemonic, so will be ignored
2025-09-13 16:08:17,981 - stdatamodels.dynamicdq - WARNING - Keyword UNCERTAIN does not correspond to an existing DQ mnemonic, so will be ignored
2025-09-13 16:08:18,067 - jwst.saturation.saturation - INFO - Using read_pattern with nframes 4
2025-09-13 16:08:18,435 - stcal.saturation.saturation - INFO - Detected 827 saturated pixels
2025-09-13 16:08:18,448 - stcal.saturation.saturation - INFO - Detected 1 A/D floor pixels
2025-09-13 16:08:18,454 - stpipe.Detector1Pipeline.saturation - INFO - Step saturation done
2025-09-13 16:08:18,618 - stpipe.Detector1Pipeline.ipc - INFO - Step ipc running with args (<RampModel(1, 5, 2048, 2048) from jw02079004003_02101_00001_nis_uncal.fits>,).
2025-09-13 16:08:18,619 - stpipe.Detector1Pipeline.ipc - INFO - Step skipped.
2025-09-13 16:08:18,781 - stpipe.Detector1Pipeline.superbias - INFO - Step superbias running with args (<RampModel(1, 5, 2048, 2048) from jw02079004003_02101_00001_nis_uncal.fits>,).
2025-09-13 16:08:18,796 - stpipe.Detector1Pipeline.superbias - INFO - Using SUPERBIAS reference file /home/runner/crds/references/jwst/niriss/jwst_niriss_superbias_0238.fits
2025-09-13 16:08:18,915 - stpipe.Detector1Pipeline.superbias - INFO - Step superbias done
2025-09-13 16:08:19,085 - stpipe.Detector1Pipeline.refpix - INFO - Step refpix running with args (<RampModel(1, 5, 2048, 2048) from jw02079004003_02101_00001_nis_uncal.fits>,).
2025-09-13 16:08:19,109 - jwst.refpix.reference_pixels - INFO - NIR full frame data
2025-09-13 16:08:19,110 - jwst.refpix.reference_pixels - INFO - The following parameters are valid for this mode:
2025-09-13 16:08:19,111 - jwst.refpix.reference_pixels - INFO - use_side_ref_pixels = True
2025-09-13 16:08:19,111 - jwst.refpix.reference_pixels - INFO - odd_even_columns = True
2025-09-13 16:08:19,112 - jwst.refpix.reference_pixels - INFO - side_smoothing_length = 11
2025-09-13 16:08:19,112 - jwst.refpix.reference_pixels - INFO - side_gain = 1.0
2025-09-13 16:08:19,113 - jwst.refpix.reference_pixels - INFO - The following parameter is not applicable and is ignored:
2025-09-13 16:08:19,113 - jwst.refpix.reference_pixels - INFO - odd_even_rows = False
2025-09-13 16:08:20,423 - stpipe.Detector1Pipeline.refpix - INFO - Step refpix done
2025-09-13 16:08:20,594 - stpipe.Detector1Pipeline.linearity - INFO - Step linearity running with args (<RampModel(1, 5, 2048, 2048) from jw02079004003_02101_00001_nis_uncal.fits>,).
2025-09-13 16:08:20,610 - stpipe.Detector1Pipeline.linearity - INFO - Using Linearity reference file /home/runner/crds/references/jwst/niriss/jwst_niriss_linearity_0017.fits
2025-09-13 16:08:20,663 - stdatamodels.dynamicdq - WARNING - Keyword LOWILLUM does not correspond to an existing DQ mnemonic, so will be ignored
2025-09-13 16:08:20,664 - stdatamodels.dynamicdq - WARNING - Keyword LOWRESP does not correspond to an existing DQ mnemonic, so will be ignored
2025-09-13 16:08:20,672 - stdatamodels.dynamicdq - WARNING - Keyword UNCERTAIN does not correspond to an existing DQ mnemonic, so will be ignored
2025-09-13 16:08:20,995 - stpipe.Detector1Pipeline.linearity - INFO - Step linearity done
2025-09-13 16:08:21,163 - stpipe.Detector1Pipeline.persistence - INFO - Step persistence running with args (<RampModel(1, 5, 2048, 2048) from jw02079004003_02101_00001_nis_uncal.fits>,).
2025-09-13 16:08:22,545 - stpipe.Detector1Pipeline.persistence - INFO - Saved model in /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage1/jw02079004003_02101_00001_nis_trapsfilled.fits
2025-09-13 16:08:22,552 - stpipe.Detector1Pipeline.persistence - INFO - Step persistence done
2025-09-13 16:08:22,722 - stpipe.Detector1Pipeline.dark_current - INFO - Step dark_current running with args (<RampModel(1, 5, 2048, 2048) from jw02079004003_02101_00001_nis_uncal.fits>,).
2025-09-13 16:08:22,734 - stpipe.Detector1Pipeline.dark_current - INFO - Using DARK reference file /home/runner/crds/references/jwst/niriss/jwst_niriss_dark_0228.fits
2025-09-13 16:08:22,967 - stcal.dark_current.dark_sub - INFO - Science data nints=1, ngroups=5, nframes=4, groupgap=0
2025-09-13 16:08:22,968 - stcal.dark_current.dark_sub - INFO - Dark data nints=1, ngroups=30, nframes=4, groupgap=0
2025-09-13 16:08:23,117 - stpipe.Detector1Pipeline.dark_current - INFO - Step dark_current done
2025-09-13 16:08:23,287 - stpipe.Detector1Pipeline.charge_migration - INFO - Step charge_migration running with args (<RampModel(1, 5, 2048, 2048) from jw02079004003_02101_00001_nis_uncal.fits>,).
2025-09-13 16:08:23,311 - jwst.charge_migration.charge_migration - INFO - Using signal_threshold: 22314.00
2025-09-13 16:08:23,393 - stpipe.Detector1Pipeline.charge_migration - INFO - Step charge_migration done
2025-09-13 16:08:23,560 - stpipe.Detector1Pipeline.jump - INFO - Step jump running with args (<RampModel(1, 5, 2048, 2048) from jw02079004003_02101_00001_nis_uncal.fits>,).
2025-09-13 16:08:23,567 - stpipe.Detector1Pipeline.jump - INFO - CR rejection threshold = 4 sigma
2025-09-13 16:08:23,567 - stpipe.Detector1Pipeline.jump - INFO - Maximum cores to use = 1
2025-09-13 16:08:23,612 - stpipe.Detector1Pipeline.jump - INFO - Using GAIN reference file: /home/runner/crds/references/jwst/niriss/jwst_niriss_gain_0006.fits
2025-09-13 16:08:23,614 - stpipe.Detector1Pipeline.jump - INFO - Using READNOISE reference file: /home/runner/crds/references/jwst/niriss/jwst_niriss_readnoise_0005.fits
2025-09-13 16:08:23,739 - stcal.jump.jump - INFO - Executing two-point difference method
2025-09-13 16:08:26,898 - stcal.jump.jump - INFO - Flagging Snowballs
2025-09-13 16:08:27,121 - stcal.jump.jump - INFO - Total snowballs = 22
2025-09-13 16:08:27,122 - stcal.jump.jump - INFO - Total elapsed time = 3.3824 sec
2025-09-13 16:08:27,150 - stpipe.Detector1Pipeline.jump - INFO - The execution time in seconds: 3.583143
2025-09-13 16:08:27,153 - stpipe.Detector1Pipeline.jump - INFO - Step jump done
2025-09-13 16:08:27,323 - stpipe.Detector1Pipeline.clean_flicker_noise - INFO - Step clean_flicker_noise running with args (<RampModel(1, 5, 2048, 2048) from jw02079004003_02101_00001_nis_uncal.fits>,).
2025-09-13 16:08:27,324 - stpipe.Detector1Pipeline.clean_flicker_noise - INFO - Step skipped.
2025-09-13 16:08:27,500 - stpipe.Detector1Pipeline.ramp_fit - INFO - Step ramp_fit running with args (<RampModel(1, 5, 2048, 2048) from jw02079004003_02101_00001_nis_uncal.fits>,).
2025-09-13 16:08:27,536 - jwst.ramp_fitting.ramp_fit_step - INFO - Using READNOISE reference file: /home/runner/crds/references/jwst/niriss/jwst_niriss_readnoise_0005.fits
2025-09-13 16:08:27,537 - jwst.ramp_fitting.ramp_fit_step - INFO - Using GAIN reference file: /home/runner/crds/references/jwst/niriss/jwst_niriss_gain_0006.fits
2025-09-13 16:08:27,564 - jwst.ramp_fitting.ramp_fit_step - INFO - Using algorithm = OLS_C
2025-09-13 16:08:27,565 - jwst.ramp_fitting.ramp_fit_step - INFO - Using weighting = optimal
2025-09-13 16:08:27,676 - stcal.ramp_fitting.ols_fit - INFO - Number of multiprocessing slices: 1
2025-09-13 16:08:29,513 - stcal.ramp_fitting.ols_fit - INFO - Ramp Fitting C Time: 1.8332877159118652
2025-09-13 16:08:29,564 - stpipe.Detector1Pipeline.ramp_fit - INFO - Step ramp_fit done
2025-09-13 16:08:29,732 - stpipe.Detector1Pipeline.gain_scale - INFO - Step gain_scale running with args (<ImageModel(2048, 2048) from jw02079004003_02101_00001_nis_uncal.fits>,).
2025-09-13 16:08:29,758 - stpipe.Detector1Pipeline.gain_scale - INFO - GAINFACT not found in gain reference file
2025-09-13 16:08:29,758 - stpipe.Detector1Pipeline.gain_scale - INFO - Step will be skipped
2025-09-13 16:08:29,760 - stpipe.Detector1Pipeline.gain_scale - INFO - Step gain_scale done
2025-09-13 16:08:29,925 - stpipe.Detector1Pipeline.gain_scale - INFO - Step gain_scale running with args (<CubeModel(1, 2048, 2048) from jw02079004003_02101_00001_nis_uncal.fits>,).
2025-09-13 16:08:29,946 - stpipe.Detector1Pipeline.gain_scale - INFO - GAINFACT not found in gain reference file
2025-09-13 16:08:29,946 - stpipe.Detector1Pipeline.gain_scale - INFO - Step will be skipped
2025-09-13 16:08:29,948 - stpipe.Detector1Pipeline.gain_scale - INFO - Step gain_scale done
2025-09-13 16:08:30,060 - stpipe.Detector1Pipeline - INFO - Saved model in /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage1/jw02079004003_02101_00001_nis_rateints.fits
2025-09-13 16:08:30,061 - jwst.pipeline.calwebb_detector1 - INFO - ... ending calwebb_detector1
2025-09-13 16:08:30,062 - jwst.stpipe.core - INFO - Results used CRDS context: jwst_1413.pmap
2025-09-13 16:08:30,172 - stpipe.Detector1Pipeline - INFO - Saved model in /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage1/jw02079004003_02101_00001_nis_rate.fits
2025-09-13 16:08:30,173 - stpipe.Detector1Pipeline - INFO - Step Detector1Pipeline done
2025-09-13 16:08:30,173 - jwst.stpipe.core - INFO - Results used jwst version: 1.19.1
2025-09-13 16:08:30,202 - CRDS - ERROR - Error determining best reference for 'pars-darkcurrentstep' = No match found.
2025-09-13 16:08:30,205 - CRDS - INFO - Fetching /home/runner/crds/references/jwst/niriss/jwst_niriss_pars-chargemigrationstep_0019.asdf 1.1 K bytes (1 / 1 files) (0 / 1.1 K bytes)
2025-09-13 16:08:30,451 - stpipe - INFO - PARS-CHARGEMIGRATIONSTEP parameters found: /home/runner/crds/references/jwst/niriss/jwst_niriss_pars-chargemigrationstep_0019.asdf
2025-09-13 16:08:30,460 - CRDS - INFO - Fetching /home/runner/crds/references/jwst/niriss/jwst_niriss_pars-jumpstep_0078.asdf 1.6 K bytes (1 / 1 files) (0 / 1.6 K bytes)
2025-09-13 16:08:30,703 - stpipe - INFO - PARS-JUMPSTEP parameters found: /home/runner/crds/references/jwst/niriss/jwst_niriss_pars-jumpstep_0078.asdf
2025-09-13 16:08:30,714 - stpipe - INFO - PARS-DETECTOR1PIPELINE parameters found: /home/runner/crds/references/jwst/niriss/jwst_niriss_pars-detector1pipeline_0001.asdf
2025-09-13 16:08:30,729 - stpipe.Detector1Pipeline - INFO - Detector1Pipeline instance created.
2025-09-13 16:08:30,730 - stpipe.Detector1Pipeline.group_scale - INFO - GroupScaleStep instance created.
2025-09-13 16:08:30,731 - stpipe.Detector1Pipeline.dq_init - INFO - DQInitStep instance created.
2025-09-13 16:08:30,732 - stpipe.Detector1Pipeline.emicorr - INFO - EmiCorrStep instance created.
2025-09-13 16:08:30,733 - stpipe.Detector1Pipeline.saturation - INFO - SaturationStep instance created.
2025-09-13 16:08:30,734 - stpipe.Detector1Pipeline.ipc - INFO - IPCStep instance created.
2025-09-13 16:08:30,735 - stpipe.Detector1Pipeline.superbias - INFO - SuperBiasStep instance created.
2025-09-13 16:08:30,736 - stpipe.Detector1Pipeline.refpix - INFO - RefPixStep instance created.
2025-09-13 16:08:30,737 - stpipe.Detector1Pipeline.rscd - INFO - RscdStep instance created.
2025-09-13 16:08:30,738 - stpipe.Detector1Pipeline.firstframe - INFO - FirstFrameStep instance created.
2025-09-13 16:08:30,738 - stpipe.Detector1Pipeline.lastframe - INFO - LastFrameStep instance created.
2025-09-13 16:08:30,739 - stpipe.Detector1Pipeline.linearity - INFO - LinearityStep instance created.
2025-09-13 16:08:30,741 - stpipe.Detector1Pipeline.dark_current - INFO - DarkCurrentStep instance created.
2025-09-13 16:08:30,742 - stpipe.Detector1Pipeline.reset - INFO - ResetStep instance created.
2025-09-13 16:08:30,743 - stpipe.Detector1Pipeline.persistence - INFO - PersistenceStep instance created.
2025-09-13 16:08:30,744 - stpipe.Detector1Pipeline.charge_migration - INFO - ChargeMigrationStep instance created.
2025-09-13 16:08:30,746 - stpipe.Detector1Pipeline.jump - INFO - JumpStep instance created.
2025-09-13 16:08:30,747 - stpipe.Detector1Pipeline.clean_flicker_noise - INFO - CleanFlickerNoiseStep instance created.
2025-09-13 16:08:30,748 - stpipe.Detector1Pipeline.ramp_fit - INFO - RampFitStep instance created.
2025-09-13 16:08:30,749 - stpipe.Detector1Pipeline.gain_scale - INFO - GainScaleStep instance created.
2025-09-13 16:08:30,918 - stpipe.Detector1Pipeline - INFO - Step Detector1Pipeline running with args ('/home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/uncal/jw02079004003_03101_00001_nis_uncal.fits',).
2025-09-13 16:08:30,938 - stpipe.Detector1Pipeline - INFO - Step Detector1Pipeline parameters are:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage1
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: True
skip: False
suffix: None
search_output_file: True
input_dir: ''
save_calibrated_ramp: False
steps:
group_scale:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
dq_init:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
emicorr:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: True
suffix: None
search_output_file: True
input_dir: ''
algorithm: joint
nints_to_phase: None
nbins: None
scale_reference: True
onthefly_corr_freq: None
use_n_cycles: 3
fit_ints_separately: False
user_supplied_reffile: None
save_intermediate_results: False
saturation:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
n_pix_grow_sat: 1
use_readpatt: True
ipc:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: True
suffix: None
search_output_file: True
input_dir: ''
superbias:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
refpix:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
odd_even_columns: True
use_side_ref_pixels: True
side_smoothing_length: 11
side_gain: 1.0
odd_even_rows: True
ovr_corr_mitigation_ftr: 3.0
preserve_irs2_refpix: False
irs2_mean_subtraction: False
refpix_algorithm: median
sigreject: 4.0
gaussmooth: 1.0
halfwidth: 30
rscd:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
firstframe:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
bright_use_group1: False
lastframe:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
linearity:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
dark_current:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
dark_output: None
average_dark_current: None
reset:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
persistence:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
input_trapsfilled: ''
flag_pers_cutoff: 40.0
save_persistence: False
save_trapsfilled: True
modify_input: False
charge_migration:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
signal_threshold: 22314.0
jump:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
rejection_threshold: 6.0
three_group_rejection_threshold: 6.0
four_group_rejection_threshold: 5.0
maximum_cores: '1'
flag_4_neighbors: False
max_jump_to_flag_neighbors: 200.0
min_jump_to_flag_neighbors: 10.0
after_jump_flag_dn1: 1000
after_jump_flag_time1: 90
after_jump_flag_dn2: 0
after_jump_flag_time2: 0
expand_large_events: True
min_sat_area: 5
min_jump_area: 15.0
expand_factor: 1.75
use_ellipses: False
sat_required_snowball: True
min_sat_radius_extend: 5.0
sat_expand: 0
edge_size: 20
mask_snowball_core_next_int: True
snowball_time_masked_next_int: 4000
find_showers: False
max_shower_amplitude: 4.0
extend_snr_threshold: 1.2
extend_min_area: 90
extend_inner_radius: 1.0
extend_outer_radius: 2.6
extend_ellipse_expand_ratio: 1.1
time_masked_after_shower: 15.0
min_diffs_single_pass: 10
max_extended_radius: 100
minimum_groups: 3
minimum_sigclip_groups: 100
only_use_ints: True
clean_flicker_noise:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: True
suffix: None
search_output_file: True
input_dir: ''
fit_method: median
fit_by_channel: False
background_method: median
background_box_size: None
mask_science_regions: False
apply_flat_field: False
n_sigma: 2.0
fit_histogram: False
single_mask: True
user_mask: None
save_mask: False
save_background: False
save_noise: False
ramp_fit:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
algorithm: OLS_C
int_name: ''
save_opt: False
opt_name: ''
suppress_one_group: True
firstgroup: None
lastgroup: None
maximum_cores: '1'
gain_scale:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
2025-09-13 16:08:30,957 - stpipe.Detector1Pipeline - INFO - Prefetching reference files for dataset: 'jw02079004003_03101_00001_nis_uncal.fits' reftypes = ['dark', 'gain', 'linearity', 'mask', 'persat', 'readnoise', 'refpix', 'reset', 'rscd', 'saturation', 'sirskernel', 'superbias', 'trapdensity', 'trappars']
2025-09-13 16:08:30,960 - stpipe.Detector1Pipeline - INFO - Prefetch for DARK reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_dark_0228.fits'.
2025-09-13 16:08:30,961 - stpipe.Detector1Pipeline - INFO - Prefetch for GAIN reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_gain_0006.fits'.
2025-09-13 16:08:30,962 - stpipe.Detector1Pipeline - INFO - Prefetch for LINEARITY reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_linearity_0017.fits'.
2025-09-13 16:08:30,962 - stpipe.Detector1Pipeline - INFO - Prefetch for MASK reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_mask_0035.fits'.
2025-09-13 16:08:30,963 - stpipe.Detector1Pipeline - INFO - Prefetch for PERSAT reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_persat_0004.fits'.
2025-09-13 16:08:30,963 - stpipe.Detector1Pipeline - INFO - Prefetch for READNOISE reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_readnoise_0005.fits'.
2025-09-13 16:08:30,964 - stpipe.Detector1Pipeline - INFO - Prefetch for REFPIX reference file is 'N/A'.
2025-09-13 16:08:30,964 - stpipe.Detector1Pipeline - INFO - Prefetch for RESET reference file is 'N/A'.
2025-09-13 16:08:30,965 - stpipe.Detector1Pipeline - INFO - Prefetch for RSCD reference file is 'N/A'.
2025-09-13 16:08:30,965 - stpipe.Detector1Pipeline - INFO - Prefetch for SATURATION reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_saturation_0015.fits'.
2025-09-13 16:08:30,966 - stpipe.Detector1Pipeline - INFO - Prefetch for SIRSKERNEL reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_sirskernel_0001.asdf'.
2025-09-13 16:08:30,966 - stpipe.Detector1Pipeline - INFO - Prefetch for SUPERBIAS reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_superbias_0238.fits'.
2025-09-13 16:08:30,967 - stpipe.Detector1Pipeline - INFO - Prefetch for TRAPDENSITY reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_trapdensity_0002.fits'.
2025-09-13 16:08:30,967 - stpipe.Detector1Pipeline - INFO - Prefetch for TRAPPARS reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_trappars_0002.fits'.
2025-09-13 16:08:30,967 - jwst.pipeline.calwebb_detector1 - INFO - Starting calwebb_detector1 ...
2025-09-13 16:08:32,091 - stpipe.Detector1Pipeline.group_scale - INFO - Step group_scale running with args (<RampModel(6, 20, 2048, 2048) from jw02079004003_03101_00001_nis_uncal.fits>,).
2025-09-13 16:08:32,098 - stpipe.Detector1Pipeline.group_scale - INFO - NFRAMES and FRMDIVSR are equal; correction not needed
2025-09-13 16:08:32,099 - stpipe.Detector1Pipeline.group_scale - INFO - Step will be skipped
2025-09-13 16:08:32,100 - stpipe.Detector1Pipeline.group_scale - INFO - Step group_scale done
2025-09-13 16:08:32,269 - stpipe.Detector1Pipeline.dq_init - INFO - Step dq_init running with args (<RampModel(6, 20, 2048, 2048) from jw02079004003_03101_00001_nis_uncal.fits>,).
2025-09-13 16:08:32,278 - stpipe.Detector1Pipeline.dq_init - INFO - Using MASK reference file /home/runner/crds/references/jwst/niriss/jwst_niriss_mask_0035.fits
2025-09-13 16:08:33,219 - stpipe.Detector1Pipeline.dq_init - INFO - Step dq_init done
2025-09-13 16:08:33,396 - stpipe.Detector1Pipeline.saturation - INFO - Step saturation running with args (<RampModel(6, 20, 2048, 2048) from jw02079004003_03101_00001_nis_uncal.fits>,).
2025-09-13 16:08:33,407 - stpipe.Detector1Pipeline.saturation - INFO - Using SATURATION reference file /home/runner/crds/references/jwst/niriss/jwst_niriss_saturation_0015.fits
2025-09-13 16:08:33,407 - stpipe.Detector1Pipeline.saturation - INFO - Using SUPERBIAS reference file /home/runner/crds/references/jwst/niriss/jwst_niriss_superbias_0238.fits
2025-09-13 16:08:33,433 - stdatamodels.dynamicdq - WARNING - Keyword LOWILLUM does not correspond to an existing DQ mnemonic, so will be ignored
2025-09-13 16:08:33,434 - stdatamodels.dynamicdq - WARNING - Keyword LOWRESP does not correspond to an existing DQ mnemonic, so will be ignored
2025-09-13 16:08:33,438 - stdatamodels.dynamicdq - WARNING - Keyword UNCERTAIN does not correspond to an existing DQ mnemonic, so will be ignored
2025-09-13 16:08:33,829 - jwst.saturation.saturation - INFO - Using read_pattern with nframes 4
2025-09-13 16:08:40,527 - stcal.saturation.saturation - INFO - Detected 18968 saturated pixels
2025-09-13 16:08:40,669 - stcal.saturation.saturation - INFO - Detected 3 A/D floor pixels
2025-09-13 16:08:40,675 - stpipe.Detector1Pipeline.saturation - INFO - Step saturation done
2025-09-13 16:08:40,872 - stpipe.Detector1Pipeline.ipc - INFO - Step ipc running with args (<RampModel(6, 20, 2048, 2048) from jw02079004003_03101_00001_nis_uncal.fits>,).
2025-09-13 16:08:40,872 - stpipe.Detector1Pipeline.ipc - INFO - Step skipped.
2025-09-13 16:08:41,042 - stpipe.Detector1Pipeline.superbias - INFO - Step superbias running with args (<RampModel(6, 20, 2048, 2048) from jw02079004003_03101_00001_nis_uncal.fits>,).
2025-09-13 16:08:41,051 - stpipe.Detector1Pipeline.superbias - INFO - Using SUPERBIAS reference file /home/runner/crds/references/jwst/niriss/jwst_niriss_superbias_0238.fits
2025-09-13 16:08:42,701 - stpipe.Detector1Pipeline.superbias - INFO - Step superbias done
2025-09-13 16:08:42,878 - stpipe.Detector1Pipeline.refpix - INFO - Step refpix running with args (<RampModel(6, 20, 2048, 2048) from jw02079004003_03101_00001_nis_uncal.fits>,).
2025-09-13 16:08:43,230 - jwst.refpix.reference_pixels - INFO - NIR full frame data
2025-09-13 16:08:43,231 - jwst.refpix.reference_pixels - INFO - The following parameters are valid for this mode:
2025-09-13 16:08:43,231 - jwst.refpix.reference_pixels - INFO - use_side_ref_pixels = True
2025-09-13 16:08:43,232 - jwst.refpix.reference_pixels - INFO - odd_even_columns = True
2025-09-13 16:08:43,232 - jwst.refpix.reference_pixels - INFO - side_smoothing_length = 11
2025-09-13 16:08:43,233 - jwst.refpix.reference_pixels - INFO - side_gain = 1.0
2025-09-13 16:08:43,233 - jwst.refpix.reference_pixels - INFO - The following parameter is not applicable and is ignored:
2025-09-13 16:08:43,233 - jwst.refpix.reference_pixels - INFO - odd_even_rows = False
2025-09-13 16:09:13,012 - stpipe.Detector1Pipeline.refpix - INFO - Step refpix done
2025-09-13 16:09:13,192 - stpipe.Detector1Pipeline.linearity - INFO - Step linearity running with args (<RampModel(6, 20, 2048, 2048) from jw02079004003_03101_00001_nis_uncal.fits>,).
2025-09-13 16:09:13,201 - stpipe.Detector1Pipeline.linearity - INFO - Using Linearity reference file /home/runner/crds/references/jwst/niriss/jwst_niriss_linearity_0017.fits
2025-09-13 16:09:13,240 - stdatamodels.dynamicdq - WARNING - Keyword LOWILLUM does not correspond to an existing DQ mnemonic, so will be ignored
2025-09-13 16:09:13,241 - stdatamodels.dynamicdq - WARNING - Keyword LOWRESP does not correspond to an existing DQ mnemonic, so will be ignored
2025-09-13 16:09:13,245 - stdatamodels.dynamicdq - WARNING - Keyword UNCERTAIN does not correspond to an existing DQ mnemonic, so will be ignored
2025-09-13 16:09:17,455 - stpipe.Detector1Pipeline.linearity - INFO - Step linearity done
2025-09-13 16:09:17,639 - stpipe.Detector1Pipeline.persistence - INFO - Step persistence running with args (<RampModel(6, 20, 2048, 2048) from jw02079004003_03101_00001_nis_uncal.fits>,).
2025-09-13 16:09:39,770 - stpipe.Detector1Pipeline.persistence - INFO - Saved model in /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage1/jw02079004003_03101_00001_nis_trapsfilled.fits
2025-09-13 16:09:39,773 - stpipe.Detector1Pipeline.persistence - INFO - Step persistence done
2025-09-13 16:09:39,957 - stpipe.Detector1Pipeline.dark_current - INFO - Step dark_current running with args (<RampModel(6, 20, 2048, 2048) from jw02079004003_03101_00001_nis_uncal.fits>,).
2025-09-13 16:09:39,966 - stpipe.Detector1Pipeline.dark_current - INFO - Using DARK reference file /home/runner/crds/references/jwst/niriss/jwst_niriss_dark_0228.fits
2025-09-13 16:09:40,504 - stcal.dark_current.dark_sub - INFO - Science data nints=6, ngroups=20, nframes=4, groupgap=0
2025-09-13 16:09:40,505 - stcal.dark_current.dark_sub - INFO - Dark data nints=1, ngroups=30, nframes=4, groupgap=0
2025-09-13 16:09:41,380 - stpipe.Detector1Pipeline.dark_current - INFO - Step dark_current done
2025-09-13 16:09:41,566 - stpipe.Detector1Pipeline.charge_migration - INFO - Step charge_migration running with args (<RampModel(6, 20, 2048, 2048) from jw02079004003_03101_00001_nis_uncal.fits>,).
2025-09-13 16:09:41,920 - jwst.charge_migration.charge_migration - INFO - Using signal_threshold: 22314.00
2025-09-13 16:09:45,267 - stpipe.Detector1Pipeline.charge_migration - INFO - Step charge_migration done
2025-09-13 16:09:45,453 - stpipe.Detector1Pipeline.jump - INFO - Step jump running with args (<RampModel(6, 20, 2048, 2048) from jw02079004003_03101_00001_nis_uncal.fits>,).
2025-09-13 16:09:45,461 - stpipe.Detector1Pipeline.jump - INFO - CR rejection threshold = 6 sigma
2025-09-13 16:09:45,462 - stpipe.Detector1Pipeline.jump - INFO - Maximum cores to use = 1
2025-09-13 16:09:45,817 - stpipe.Detector1Pipeline.jump - INFO - Using GAIN reference file: /home/runner/crds/references/jwst/niriss/jwst_niriss_gain_0006.fits
2025-09-13 16:09:45,819 - stpipe.Detector1Pipeline.jump - INFO - Using READNOISE reference file: /home/runner/crds/references/jwst/niriss/jwst_niriss_readnoise_0005.fits
2025-09-13 16:09:46,509 - stcal.jump.jump - INFO - Executing two-point difference method
2025-09-13 16:10:13,629 - stcal.jump.jump - INFO - Flagging Snowballs
2025-09-13 16:10:16,103 - stcal.jump.jump - INFO - Total snowballs = 640
2025-09-13 16:10:16,104 - stcal.jump.jump - INFO - Total elapsed time = 29.594 sec
2025-09-13 16:10:16,588 - stpipe.Detector1Pipeline.jump - INFO - The execution time in seconds: 31.127101
2025-09-13 16:10:16,591 - stpipe.Detector1Pipeline.jump - INFO - Step jump done
2025-09-13 16:10:16,769 - stpipe.Detector1Pipeline.clean_flicker_noise - INFO - Step clean_flicker_noise running with args (<RampModel(6, 20, 2048, 2048) from jw02079004003_03101_00001_nis_uncal.fits>,).
2025-09-13 16:10:16,770 - stpipe.Detector1Pipeline.clean_flicker_noise - INFO - Step skipped.
2025-09-13 16:10:16,938 - stpipe.Detector1Pipeline.ramp_fit - INFO - Step ramp_fit running with args (<RampModel(6, 20, 2048, 2048) from jw02079004003_03101_00001_nis_uncal.fits>,).
2025-09-13 16:10:17,291 - jwst.ramp_fitting.ramp_fit_step - INFO - Using READNOISE reference file: /home/runner/crds/references/jwst/niriss/jwst_niriss_readnoise_0005.fits
2025-09-13 16:10:17,291 - jwst.ramp_fitting.ramp_fit_step - INFO - Using GAIN reference file: /home/runner/crds/references/jwst/niriss/jwst_niriss_gain_0006.fits
2025-09-13 16:10:17,318 - jwst.ramp_fitting.ramp_fit_step - INFO - Using algorithm = OLS_C
2025-09-13 16:10:17,318 - jwst.ramp_fitting.ramp_fit_step - INFO - Using weighting = optimal
2025-09-13 16:10:18,924 - stcal.ramp_fitting.ols_fit - INFO - Number of multiprocessing slices: 1
2025-09-13 16:10:58,851 - stcal.ramp_fitting.ols_fit - INFO - Ramp Fitting C Time: 39.91964030265808
2025-09-13 16:10:58,901 - stpipe.Detector1Pipeline.ramp_fit - INFO - Step ramp_fit done
2025-09-13 16:10:59,093 - stpipe.Detector1Pipeline.gain_scale - INFO - Step gain_scale running with args (<ImageModel(2048, 2048) from jw02079004003_03101_00001_nis_uncal.fits>,).
2025-09-13 16:10:59,113 - stpipe.Detector1Pipeline.gain_scale - INFO - GAINFACT not found in gain reference file
2025-09-13 16:10:59,114 - stpipe.Detector1Pipeline.gain_scale - INFO - Step will be skipped
2025-09-13 16:10:59,116 - stpipe.Detector1Pipeline.gain_scale - INFO - Step gain_scale done
2025-09-13 16:10:59,296 - stpipe.Detector1Pipeline.gain_scale - INFO - Step gain_scale running with args (<CubeModel(6, 2048, 2048) from jw02079004003_03101_00001_nis_uncal.fits>,).
2025-09-13 16:10:59,317 - stpipe.Detector1Pipeline.gain_scale - INFO - GAINFACT not found in gain reference file
2025-09-13 16:10:59,318 - stpipe.Detector1Pipeline.gain_scale - INFO - Step will be skipped
2025-09-13 16:10:59,320 - stpipe.Detector1Pipeline.gain_scale - INFO - Step gain_scale done
2025-09-13 16:10:59,747 - stpipe.Detector1Pipeline - INFO - Saved model in /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage1/jw02079004003_03101_00001_nis_rateints.fits
2025-09-13 16:10:59,748 - jwst.pipeline.calwebb_detector1 - INFO - ... ending calwebb_detector1
2025-09-13 16:10:59,751 - jwst.stpipe.core - INFO - Results used CRDS context: jwst_1413.pmap
2025-09-13 16:10:59,862 - stpipe.Detector1Pipeline - INFO - Saved model in /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage1/jw02079004003_03101_00001_nis_rate.fits
2025-09-13 16:10:59,863 - stpipe.Detector1Pipeline - INFO - Step Detector1Pipeline done
2025-09-13 16:10:59,863 - jwst.stpipe.core - INFO - Results used jwst version: 1.19.1
2025-09-13 16:10:59,894 - CRDS - ERROR - Error determining best reference for 'pars-darkcurrentstep' = No match found.
2025-09-13 16:10:59,898 - stpipe - INFO - PARS-CHARGEMIGRATIONSTEP parameters found: /home/runner/crds/references/jwst/niriss/jwst_niriss_pars-chargemigrationstep_0019.asdf
2025-09-13 16:10:59,906 - stpipe - INFO - PARS-JUMPSTEP parameters found: /home/runner/crds/references/jwst/niriss/jwst_niriss_pars-jumpstep_0078.asdf
2025-09-13 16:10:59,917 - stpipe - INFO - PARS-DETECTOR1PIPELINE parameters found: /home/runner/crds/references/jwst/niriss/jwst_niriss_pars-detector1pipeline_0001.asdf
2025-09-13 16:10:59,932 - stpipe.Detector1Pipeline - INFO - Detector1Pipeline instance created.
2025-09-13 16:10:59,933 - stpipe.Detector1Pipeline.group_scale - INFO - GroupScaleStep instance created.
2025-09-13 16:10:59,934 - stpipe.Detector1Pipeline.dq_init - INFO - DQInitStep instance created.
2025-09-13 16:10:59,935 - stpipe.Detector1Pipeline.emicorr - INFO - EmiCorrStep instance created.
2025-09-13 16:10:59,935 - stpipe.Detector1Pipeline.saturation - INFO - SaturationStep instance created.
2025-09-13 16:10:59,936 - stpipe.Detector1Pipeline.ipc - INFO - IPCStep instance created.
2025-09-13 16:10:59,937 - stpipe.Detector1Pipeline.superbias - INFO - SuperBiasStep instance created.
2025-09-13 16:10:59,938 - stpipe.Detector1Pipeline.refpix - INFO - RefPixStep instance created.
2025-09-13 16:10:59,938 - stpipe.Detector1Pipeline.rscd - INFO - RscdStep instance created.
2025-09-13 16:10:59,939 - stpipe.Detector1Pipeline.firstframe - INFO - FirstFrameStep instance created.
2025-09-13 16:10:59,940 - stpipe.Detector1Pipeline.lastframe - INFO - LastFrameStep instance created.
2025-09-13 16:10:59,941 - stpipe.Detector1Pipeline.linearity - INFO - LinearityStep instance created.
2025-09-13 16:10:59,942 - stpipe.Detector1Pipeline.dark_current - INFO - DarkCurrentStep instance created.
2025-09-13 16:10:59,942 - stpipe.Detector1Pipeline.reset - INFO - ResetStep instance created.
2025-09-13 16:10:59,943 - stpipe.Detector1Pipeline.persistence - INFO - PersistenceStep instance created.
2025-09-13 16:10:59,944 - stpipe.Detector1Pipeline.charge_migration - INFO - ChargeMigrationStep instance created.
2025-09-13 16:10:59,946 - stpipe.Detector1Pipeline.jump - INFO - JumpStep instance created.
2025-09-13 16:10:59,947 - stpipe.Detector1Pipeline.clean_flicker_noise - INFO - CleanFlickerNoiseStep instance created.
2025-09-13 16:10:59,947 - stpipe.Detector1Pipeline.ramp_fit - INFO - RampFitStep instance created.
2025-09-13 16:10:59,948 - stpipe.Detector1Pipeline.gain_scale - INFO - GainScaleStep instance created.
2025-09-13 16:11:00,133 - stpipe.Detector1Pipeline - INFO - Step Detector1Pipeline running with args ('/home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/uncal/jw02079004003_03101_00002_nis_uncal.fits',).
2025-09-13 16:11:00,153 - stpipe.Detector1Pipeline - INFO - Step Detector1Pipeline parameters are:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage1
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: True
skip: False
suffix: None
search_output_file: True
input_dir: ''
save_calibrated_ramp: False
steps:
group_scale:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
dq_init:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
emicorr:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: True
suffix: None
search_output_file: True
input_dir: ''
algorithm: joint
nints_to_phase: None
nbins: None
scale_reference: True
onthefly_corr_freq: None
use_n_cycles: 3
fit_ints_separately: False
user_supplied_reffile: None
save_intermediate_results: False
saturation:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
n_pix_grow_sat: 1
use_readpatt: True
ipc:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: True
suffix: None
search_output_file: True
input_dir: ''
superbias:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
refpix:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
odd_even_columns: True
use_side_ref_pixels: True
side_smoothing_length: 11
side_gain: 1.0
odd_even_rows: True
ovr_corr_mitigation_ftr: 3.0
preserve_irs2_refpix: False
irs2_mean_subtraction: False
refpix_algorithm: median
sigreject: 4.0
gaussmooth: 1.0
halfwidth: 30
rscd:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
firstframe:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
bright_use_group1: False
lastframe:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
linearity:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
dark_current:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
dark_output: None
average_dark_current: None
reset:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
persistence:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
input_trapsfilled: ''
flag_pers_cutoff: 40.0
save_persistence: False
save_trapsfilled: True
modify_input: False
charge_migration:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
signal_threshold: 22314.0
jump:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
rejection_threshold: 6.0
three_group_rejection_threshold: 6.0
four_group_rejection_threshold: 5.0
maximum_cores: '1'
flag_4_neighbors: False
max_jump_to_flag_neighbors: 200.0
min_jump_to_flag_neighbors: 10.0
after_jump_flag_dn1: 1000
after_jump_flag_time1: 90
after_jump_flag_dn2: 0
after_jump_flag_time2: 0
expand_large_events: True
min_sat_area: 5
min_jump_area: 15.0
expand_factor: 1.75
use_ellipses: False
sat_required_snowball: True
min_sat_radius_extend: 5.0
sat_expand: 0
edge_size: 20
mask_snowball_core_next_int: True
snowball_time_masked_next_int: 4000
find_showers: False
max_shower_amplitude: 4.0
extend_snr_threshold: 1.2
extend_min_area: 90
extend_inner_radius: 1.0
extend_outer_radius: 2.6
extend_ellipse_expand_ratio: 1.1
time_masked_after_shower: 15.0
min_diffs_single_pass: 10
max_extended_radius: 100
minimum_groups: 3
minimum_sigclip_groups: 100
only_use_ints: True
clean_flicker_noise:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: True
suffix: None
search_output_file: True
input_dir: ''
fit_method: median
fit_by_channel: False
background_method: median
background_box_size: None
mask_science_regions: False
apply_flat_field: False
n_sigma: 2.0
fit_histogram: False
single_mask: True
user_mask: None
save_mask: False
save_background: False
save_noise: False
ramp_fit:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
algorithm: OLS_C
int_name: ''
save_opt: False
opt_name: ''
suppress_one_group: True
firstgroup: None
lastgroup: None
maximum_cores: '1'
gain_scale:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
2025-09-13 16:11:00,173 - stpipe.Detector1Pipeline - INFO - Prefetching reference files for dataset: 'jw02079004003_03101_00002_nis_uncal.fits' reftypes = ['dark', 'gain', 'linearity', 'mask', 'persat', 'readnoise', 'refpix', 'reset', 'rscd', 'saturation', 'sirskernel', 'superbias', 'trapdensity', 'trappars']
2025-09-13 16:11:00,176 - stpipe.Detector1Pipeline - INFO - Prefetch for DARK reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_dark_0228.fits'.
2025-09-13 16:11:00,176 - stpipe.Detector1Pipeline - INFO - Prefetch for GAIN reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_gain_0006.fits'.
2025-09-13 16:11:00,177 - stpipe.Detector1Pipeline - INFO - Prefetch for LINEARITY reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_linearity_0017.fits'.
2025-09-13 16:11:00,177 - stpipe.Detector1Pipeline - INFO - Prefetch for MASK reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_mask_0035.fits'.
2025-09-13 16:11:00,177 - stpipe.Detector1Pipeline - INFO - Prefetch for PERSAT reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_persat_0004.fits'.
2025-09-13 16:11:00,178 - stpipe.Detector1Pipeline - INFO - Prefetch for READNOISE reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_readnoise_0005.fits'.
2025-09-13 16:11:00,178 - stpipe.Detector1Pipeline - INFO - Prefetch for REFPIX reference file is 'N/A'.
2025-09-13 16:11:00,179 - stpipe.Detector1Pipeline - INFO - Prefetch for RESET reference file is 'N/A'.
2025-09-13 16:11:00,179 - stpipe.Detector1Pipeline - INFO - Prefetch for RSCD reference file is 'N/A'.
2025-09-13 16:11:00,179 - stpipe.Detector1Pipeline - INFO - Prefetch for SATURATION reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_saturation_0015.fits'.
2025-09-13 16:11:00,180 - stpipe.Detector1Pipeline - INFO - Prefetch for SIRSKERNEL reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_sirskernel_0001.asdf'.
2025-09-13 16:11:00,180 - stpipe.Detector1Pipeline - INFO - Prefetch for SUPERBIAS reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_superbias_0238.fits'.
2025-09-13 16:11:00,180 - stpipe.Detector1Pipeline - INFO - Prefetch for TRAPDENSITY reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_trapdensity_0002.fits'.
2025-09-13 16:11:00,181 - stpipe.Detector1Pipeline - INFO - Prefetch for TRAPPARS reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_trappars_0002.fits'.
2025-09-13 16:11:00,181 - jwst.pipeline.calwebb_detector1 - INFO - Starting calwebb_detector1 ...
2025-09-13 16:11:01,357 - stpipe.Detector1Pipeline.group_scale - INFO - Step group_scale running with args (<RampModel(6, 20, 2048, 2048) from jw02079004003_03101_00002_nis_uncal.fits>,).
2025-09-13 16:11:01,365 - stpipe.Detector1Pipeline.group_scale - INFO - NFRAMES and FRMDIVSR are equal; correction not needed
2025-09-13 16:11:01,365 - stpipe.Detector1Pipeline.group_scale - INFO - Step will be skipped
2025-09-13 16:11:01,367 - stpipe.Detector1Pipeline.group_scale - INFO - Step group_scale done
2025-09-13 16:11:01,557 - stpipe.Detector1Pipeline.dq_init - INFO - Step dq_init running with args (<RampModel(6, 20, 2048, 2048) from jw02079004003_03101_00002_nis_uncal.fits>,).
2025-09-13 16:11:01,567 - stpipe.Detector1Pipeline.dq_init - INFO - Using MASK reference file /home/runner/crds/references/jwst/niriss/jwst_niriss_mask_0035.fits
2025-09-13 16:11:02,553 - stpipe.Detector1Pipeline.dq_init - INFO - Step dq_init done
2025-09-13 16:11:02,738 - stpipe.Detector1Pipeline.saturation - INFO - Step saturation running with args (<RampModel(6, 20, 2048, 2048) from jw02079004003_03101_00002_nis_uncal.fits>,).
2025-09-13 16:11:02,748 - stpipe.Detector1Pipeline.saturation - INFO - Using SATURATION reference file /home/runner/crds/references/jwst/niriss/jwst_niriss_saturation_0015.fits
2025-09-13 16:11:02,749 - stpipe.Detector1Pipeline.saturation - INFO - Using SUPERBIAS reference file /home/runner/crds/references/jwst/niriss/jwst_niriss_superbias_0238.fits
2025-09-13 16:11:02,776 - stdatamodels.dynamicdq - WARNING - Keyword LOWILLUM does not correspond to an existing DQ mnemonic, so will be ignored
2025-09-13 16:11:02,776 - stdatamodels.dynamicdq - WARNING - Keyword LOWRESP does not correspond to an existing DQ mnemonic, so will be ignored
2025-09-13 16:11:02,781 - stdatamodels.dynamicdq - WARNING - Keyword UNCERTAIN does not correspond to an existing DQ mnemonic, so will be ignored
2025-09-13 16:11:03,201 - jwst.saturation.saturation - INFO - Using read_pattern with nframes 4
2025-09-13 16:11:10,429 - stcal.saturation.saturation - INFO - Detected 19643 saturated pixels
2025-09-13 16:11:10,579 - stcal.saturation.saturation - INFO - Detected 3 A/D floor pixels
2025-09-13 16:11:10,586 - stpipe.Detector1Pipeline.saturation - INFO - Step saturation done
2025-09-13 16:11:10,773 - stpipe.Detector1Pipeline.ipc - INFO - Step ipc running with args (<RampModel(6, 20, 2048, 2048) from jw02079004003_03101_00002_nis_uncal.fits>,).
2025-09-13 16:11:10,773 - stpipe.Detector1Pipeline.ipc - INFO - Step skipped.
2025-09-13 16:11:10,948 - stpipe.Detector1Pipeline.superbias - INFO - Step superbias running with args (<RampModel(6, 20, 2048, 2048) from jw02079004003_03101_00002_nis_uncal.fits>,).
2025-09-13 16:11:10,958 - stpipe.Detector1Pipeline.superbias - INFO - Using SUPERBIAS reference file /home/runner/crds/references/jwst/niriss/jwst_niriss_superbias_0238.fits
2025-09-13 16:11:12,750 - stpipe.Detector1Pipeline.superbias - INFO - Step superbias done
2025-09-13 16:11:12,942 - stpipe.Detector1Pipeline.refpix - INFO - Step refpix running with args (<RampModel(6, 20, 2048, 2048) from jw02079004003_03101_00002_nis_uncal.fits>,).
2025-09-13 16:11:13,325 - jwst.refpix.reference_pixels - INFO - NIR full frame data
2025-09-13 16:11:13,326 - jwst.refpix.reference_pixels - INFO - The following parameters are valid for this mode:
2025-09-13 16:11:13,326 - jwst.refpix.reference_pixels - INFO - use_side_ref_pixels = True
2025-09-13 16:11:13,326 - jwst.refpix.reference_pixels - INFO - odd_even_columns = True
2025-09-13 16:11:13,327 - jwst.refpix.reference_pixels - INFO - side_smoothing_length = 11
2025-09-13 16:11:13,327 - jwst.refpix.reference_pixels - INFO - side_gain = 1.0
2025-09-13 16:11:13,327 - jwst.refpix.reference_pixels - INFO - The following parameter is not applicable and is ignored:
2025-09-13 16:11:13,328 - jwst.refpix.reference_pixels - INFO - odd_even_rows = False
2025-09-13 16:11:43,313 - stpipe.Detector1Pipeline.refpix - INFO - Step refpix done
2025-09-13 16:11:43,518 - stpipe.Detector1Pipeline.linearity - INFO - Step linearity running with args (<RampModel(6, 20, 2048, 2048) from jw02079004003_03101_00002_nis_uncal.fits>,).
2025-09-13 16:11:43,528 - stpipe.Detector1Pipeline.linearity - INFO - Using Linearity reference file /home/runner/crds/references/jwst/niriss/jwst_niriss_linearity_0017.fits
2025-09-13 16:11:43,577 - stdatamodels.dynamicdq - WARNING - Keyword LOWILLUM does not correspond to an existing DQ mnemonic, so will be ignored
2025-09-13 16:11:43,578 - stdatamodels.dynamicdq - WARNING - Keyword LOWRESP does not correspond to an existing DQ mnemonic, so will be ignored
2025-09-13 16:11:43,583 - stdatamodels.dynamicdq - WARNING - Keyword UNCERTAIN does not correspond to an existing DQ mnemonic, so will be ignored
2025-09-13 16:11:47,991 - stpipe.Detector1Pipeline.linearity - INFO - Step linearity done
2025-09-13 16:11:48,185 - stpipe.Detector1Pipeline.persistence - INFO - Step persistence running with args (<RampModel(6, 20, 2048, 2048) from jw02079004003_03101_00002_nis_uncal.fits>,).
2025-09-13 16:12:10,812 - stpipe.Detector1Pipeline.persistence - INFO - Saved model in /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage1/jw02079004003_03101_00002_nis_trapsfilled.fits
2025-09-13 16:12:10,816 - stpipe.Detector1Pipeline.persistence - INFO - Step persistence done
2025-09-13 16:12:11,008 - stpipe.Detector1Pipeline.dark_current - INFO - Step dark_current running with args (<RampModel(6, 20, 2048, 2048) from jw02079004003_03101_00002_nis_uncal.fits>,).
2025-09-13 16:12:11,018 - stpipe.Detector1Pipeline.dark_current - INFO - Using DARK reference file /home/runner/crds/references/jwst/niriss/jwst_niriss_dark_0228.fits
2025-09-13 16:12:11,596 - stcal.dark_current.dark_sub - INFO - Science data nints=6, ngroups=20, nframes=4, groupgap=0
2025-09-13 16:12:11,596 - stcal.dark_current.dark_sub - INFO - Dark data nints=1, ngroups=30, nframes=4, groupgap=0
2025-09-13 16:12:12,504 - stpipe.Detector1Pipeline.dark_current - INFO - Step dark_current done
2025-09-13 16:12:12,706 - stpipe.Detector1Pipeline.charge_migration - INFO - Step charge_migration running with args (<RampModel(6, 20, 2048, 2048) from jw02079004003_03101_00002_nis_uncal.fits>,).
2025-09-13 16:12:13,087 - jwst.charge_migration.charge_migration - INFO - Using signal_threshold: 22314.00
2025-09-13 16:12:16,580 - stpipe.Detector1Pipeline.charge_migration - INFO - Step charge_migration done
2025-09-13 16:12:16,775 - stpipe.Detector1Pipeline.jump - INFO - Step jump running with args (<RampModel(6, 20, 2048, 2048) from jw02079004003_03101_00002_nis_uncal.fits>,).
2025-09-13 16:12:16,783 - stpipe.Detector1Pipeline.jump - INFO - CR rejection threshold = 6 sigma
2025-09-13 16:12:16,783 - stpipe.Detector1Pipeline.jump - INFO - Maximum cores to use = 1
2025-09-13 16:12:17,152 - stpipe.Detector1Pipeline.jump - INFO - Using GAIN reference file: /home/runner/crds/references/jwst/niriss/jwst_niriss_gain_0006.fits
2025-09-13 16:12:17,155 - stpipe.Detector1Pipeline.jump - INFO - Using READNOISE reference file: /home/runner/crds/references/jwst/niriss/jwst_niriss_readnoise_0005.fits
2025-09-13 16:12:17,857 - stcal.jump.jump - INFO - Executing two-point difference method
2025-09-13 16:12:45,635 - stcal.jump.jump - INFO - Flagging Snowballs
2025-09-13 16:12:48,171 - stcal.jump.jump - INFO - Total snowballs = 678
2025-09-13 16:12:48,171 - stcal.jump.jump - INFO - Total elapsed time = 30.3139 sec
2025-09-13 16:12:48,667 - stpipe.Detector1Pipeline.jump - INFO - The execution time in seconds: 31.884137
2025-09-13 16:12:48,670 - stpipe.Detector1Pipeline.jump - INFO - Step jump done
2025-09-13 16:12:48,862 - stpipe.Detector1Pipeline.clean_flicker_noise - INFO - Step clean_flicker_noise running with args (<RampModel(6, 20, 2048, 2048) from jw02079004003_03101_00002_nis_uncal.fits>,).
2025-09-13 16:12:48,862 - stpipe.Detector1Pipeline.clean_flicker_noise - INFO - Step skipped.
2025-09-13 16:12:49,043 - stpipe.Detector1Pipeline.ramp_fit - INFO - Step ramp_fit running with args (<RampModel(6, 20, 2048, 2048) from jw02079004003_03101_00002_nis_uncal.fits>,).
2025-09-13 16:12:49,416 - jwst.ramp_fitting.ramp_fit_step - INFO - Using READNOISE reference file: /home/runner/crds/references/jwst/niriss/jwst_niriss_readnoise_0005.fits
2025-09-13 16:12:49,416 - jwst.ramp_fitting.ramp_fit_step - INFO - Using GAIN reference file: /home/runner/crds/references/jwst/niriss/jwst_niriss_gain_0006.fits
2025-09-13 16:12:49,443 - jwst.ramp_fitting.ramp_fit_step - INFO - Using algorithm = OLS_C
2025-09-13 16:12:49,444 - jwst.ramp_fitting.ramp_fit_step - INFO - Using weighting = optimal
2025-09-13 16:12:51,139 - stcal.ramp_fitting.ols_fit - INFO - Number of multiprocessing slices: 1
2025-09-13 16:13:31,303 - stcal.ramp_fitting.ols_fit - INFO - Ramp Fitting C Time: 40.15742635726929
2025-09-13 16:13:31,353 - stpipe.Detector1Pipeline.ramp_fit - INFO - Step ramp_fit done
2025-09-13 16:13:31,534 - stpipe.Detector1Pipeline.gain_scale - INFO - Step gain_scale running with args (<ImageModel(2048, 2048) from jw02079004003_03101_00002_nis_uncal.fits>,).
2025-09-13 16:13:31,554 - stpipe.Detector1Pipeline.gain_scale - INFO - GAINFACT not found in gain reference file
2025-09-13 16:13:31,554 - stpipe.Detector1Pipeline.gain_scale - INFO - Step will be skipped
2025-09-13 16:13:31,556 - stpipe.Detector1Pipeline.gain_scale - INFO - Step gain_scale done
2025-09-13 16:13:31,727 - stpipe.Detector1Pipeline.gain_scale - INFO - Step gain_scale running with args (<CubeModel(6, 2048, 2048) from jw02079004003_03101_00002_nis_uncal.fits>,).
2025-09-13 16:13:31,748 - stpipe.Detector1Pipeline.gain_scale - INFO - GAINFACT not found in gain reference file
2025-09-13 16:13:31,749 - stpipe.Detector1Pipeline.gain_scale - INFO - Step will be skipped
2025-09-13 16:13:31,751 - stpipe.Detector1Pipeline.gain_scale - INFO - Step gain_scale done
2025-09-13 16:13:32,173 - stpipe.Detector1Pipeline - INFO - Saved model in /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage1/jw02079004003_03101_00002_nis_rateints.fits
2025-09-13 16:13:32,174 - jwst.pipeline.calwebb_detector1 - INFO - ... ending calwebb_detector1
2025-09-13 16:13:32,177 - jwst.stpipe.core - INFO - Results used CRDS context: jwst_1413.pmap
2025-09-13 16:13:32,288 - stpipe.Detector1Pipeline - INFO - Saved model in /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage1/jw02079004003_03101_00002_nis_rate.fits
2025-09-13 16:13:32,289 - stpipe.Detector1Pipeline - INFO - Step Detector1Pipeline done
2025-09-13 16:13:32,289 - jwst.stpipe.core - INFO - Results used jwst version: 1.19.1
2025-09-13 16:13:32,319 - CRDS - ERROR - Error determining best reference for 'pars-darkcurrentstep' = No match found.
2025-09-13 16:13:32,323 - stpipe - INFO - PARS-CHARGEMIGRATIONSTEP parameters found: /home/runner/crds/references/jwst/niriss/jwst_niriss_pars-chargemigrationstep_0019.asdf
2025-09-13 16:13:32,331 - stpipe - INFO - PARS-JUMPSTEP parameters found: /home/runner/crds/references/jwst/niriss/jwst_niriss_pars-jumpstep_0078.asdf
2025-09-13 16:13:32,342 - stpipe - INFO - PARS-DETECTOR1PIPELINE parameters found: /home/runner/crds/references/jwst/niriss/jwst_niriss_pars-detector1pipeline_0001.asdf
2025-09-13 16:13:32,358 - stpipe.Detector1Pipeline - INFO - Detector1Pipeline instance created.
2025-09-13 16:13:32,359 - stpipe.Detector1Pipeline.group_scale - INFO - GroupScaleStep instance created.
2025-09-13 16:13:32,360 - stpipe.Detector1Pipeline.dq_init - INFO - DQInitStep instance created.
2025-09-13 16:13:32,361 - stpipe.Detector1Pipeline.emicorr - INFO - EmiCorrStep instance created.
2025-09-13 16:13:32,362 - stpipe.Detector1Pipeline.saturation - INFO - SaturationStep instance created.
2025-09-13 16:13:32,363 - stpipe.Detector1Pipeline.ipc - INFO - IPCStep instance created.
2025-09-13 16:13:32,364 - stpipe.Detector1Pipeline.superbias - INFO - SuperBiasStep instance created.
2025-09-13 16:13:32,366 - stpipe.Detector1Pipeline.refpix - INFO - RefPixStep instance created.
2025-09-13 16:13:32,367 - stpipe.Detector1Pipeline.rscd - INFO - RscdStep instance created.
2025-09-13 16:13:32,368 - stpipe.Detector1Pipeline.firstframe - INFO - FirstFrameStep instance created.
2025-09-13 16:13:32,368 - stpipe.Detector1Pipeline.lastframe - INFO - LastFrameStep instance created.
2025-09-13 16:13:32,369 - stpipe.Detector1Pipeline.linearity - INFO - LinearityStep instance created.
2025-09-13 16:13:32,370 - stpipe.Detector1Pipeline.dark_current - INFO - DarkCurrentStep instance created.
2025-09-13 16:13:32,371 - stpipe.Detector1Pipeline.reset - INFO - ResetStep instance created.
2025-09-13 16:13:32,372 - stpipe.Detector1Pipeline.persistence - INFO - PersistenceStep instance created.
2025-09-13 16:13:32,373 - stpipe.Detector1Pipeline.charge_migration - INFO - ChargeMigrationStep instance created.
2025-09-13 16:13:32,375 - stpipe.Detector1Pipeline.jump - INFO - JumpStep instance created.
2025-09-13 16:13:32,376 - stpipe.Detector1Pipeline.clean_flicker_noise - INFO - CleanFlickerNoiseStep instance created.
2025-09-13 16:13:32,378 - stpipe.Detector1Pipeline.ramp_fit - INFO - RampFitStep instance created.
2025-09-13 16:13:32,379 - stpipe.Detector1Pipeline.gain_scale - INFO - GainScaleStep instance created.
2025-09-13 16:13:32,557 - stpipe.Detector1Pipeline - INFO - Step Detector1Pipeline running with args ('/home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/uncal/jw02079004003_03101_00003_nis_uncal.fits',).
2025-09-13 16:13:32,577 - stpipe.Detector1Pipeline - INFO - Step Detector1Pipeline parameters are:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage1
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: True
skip: False
suffix: None
search_output_file: True
input_dir: ''
save_calibrated_ramp: False
steps:
group_scale:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
dq_init:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
emicorr:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: True
suffix: None
search_output_file: True
input_dir: ''
algorithm: joint
nints_to_phase: None
nbins: None
scale_reference: True
onthefly_corr_freq: None
use_n_cycles: 3
fit_ints_separately: False
user_supplied_reffile: None
save_intermediate_results: False
saturation:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
n_pix_grow_sat: 1
use_readpatt: True
ipc:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: True
suffix: None
search_output_file: True
input_dir: ''
superbias:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
refpix:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
odd_even_columns: True
use_side_ref_pixels: True
side_smoothing_length: 11
side_gain: 1.0
odd_even_rows: True
ovr_corr_mitigation_ftr: 3.0
preserve_irs2_refpix: False
irs2_mean_subtraction: False
refpix_algorithm: median
sigreject: 4.0
gaussmooth: 1.0
halfwidth: 30
rscd:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
firstframe:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
bright_use_group1: False
lastframe:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
linearity:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
dark_current:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
dark_output: None
average_dark_current: None
reset:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
persistence:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
input_trapsfilled: ''
flag_pers_cutoff: 40.0
save_persistence: False
save_trapsfilled: True
modify_input: False
charge_migration:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
signal_threshold: 22314.0
jump:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
rejection_threshold: 6.0
three_group_rejection_threshold: 6.0
four_group_rejection_threshold: 5.0
maximum_cores: '1'
flag_4_neighbors: False
max_jump_to_flag_neighbors: 200.0
min_jump_to_flag_neighbors: 10.0
after_jump_flag_dn1: 1000
after_jump_flag_time1: 90
after_jump_flag_dn2: 0
after_jump_flag_time2: 0
expand_large_events: True
min_sat_area: 5
min_jump_area: 15.0
expand_factor: 1.75
use_ellipses: False
sat_required_snowball: True
min_sat_radius_extend: 5.0
sat_expand: 0
edge_size: 20
mask_snowball_core_next_int: True
snowball_time_masked_next_int: 4000
find_showers: False
max_shower_amplitude: 4.0
extend_snr_threshold: 1.2
extend_min_area: 90
extend_inner_radius: 1.0
extend_outer_radius: 2.6
extend_ellipse_expand_ratio: 1.1
time_masked_after_shower: 15.0
min_diffs_single_pass: 10
max_extended_radius: 100
minimum_groups: 3
minimum_sigclip_groups: 100
only_use_ints: True
clean_flicker_noise:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: True
suffix: None
search_output_file: True
input_dir: ''
fit_method: median
fit_by_channel: False
background_method: median
background_box_size: None
mask_science_regions: False
apply_flat_field: False
n_sigma: 2.0
fit_histogram: False
single_mask: True
user_mask: None
save_mask: False
save_background: False
save_noise: False
ramp_fit:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
algorithm: OLS_C
int_name: ''
save_opt: False
opt_name: ''
suppress_one_group: True
firstgroup: None
lastgroup: None
maximum_cores: '1'
gain_scale:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
2025-09-13 16:13:32,597 - stpipe.Detector1Pipeline - INFO - Prefetching reference files for dataset: 'jw02079004003_03101_00003_nis_uncal.fits' reftypes = ['dark', 'gain', 'linearity', 'mask', 'persat', 'readnoise', 'refpix', 'reset', 'rscd', 'saturation', 'sirskernel', 'superbias', 'trapdensity', 'trappars']
2025-09-13 16:13:32,601 - stpipe.Detector1Pipeline - INFO - Prefetch for DARK reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_dark_0228.fits'.
2025-09-13 16:13:32,601 - stpipe.Detector1Pipeline - INFO - Prefetch for GAIN reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_gain_0006.fits'.
2025-09-13 16:13:32,602 - stpipe.Detector1Pipeline - INFO - Prefetch for LINEARITY reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_linearity_0017.fits'.
2025-09-13 16:13:32,602 - stpipe.Detector1Pipeline - INFO - Prefetch for MASK reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_mask_0035.fits'.
2025-09-13 16:13:32,603 - stpipe.Detector1Pipeline - INFO - Prefetch for PERSAT reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_persat_0004.fits'.
2025-09-13 16:13:32,603 - stpipe.Detector1Pipeline - INFO - Prefetch for READNOISE reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_readnoise_0005.fits'.
2025-09-13 16:13:32,604 - stpipe.Detector1Pipeline - INFO - Prefetch for REFPIX reference file is 'N/A'.
2025-09-13 16:13:32,604 - stpipe.Detector1Pipeline - INFO - Prefetch for RESET reference file is 'N/A'.
2025-09-13 16:13:32,605 - stpipe.Detector1Pipeline - INFO - Prefetch for RSCD reference file is 'N/A'.
2025-09-13 16:13:32,605 - stpipe.Detector1Pipeline - INFO - Prefetch for SATURATION reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_saturation_0015.fits'.
2025-09-13 16:13:32,606 - stpipe.Detector1Pipeline - INFO - Prefetch for SIRSKERNEL reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_sirskernel_0001.asdf'.
2025-09-13 16:13:32,606 - stpipe.Detector1Pipeline - INFO - Prefetch for SUPERBIAS reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_superbias_0238.fits'.
2025-09-13 16:13:32,607 - stpipe.Detector1Pipeline - INFO - Prefetch for TRAPDENSITY reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_trapdensity_0002.fits'.
2025-09-13 16:13:32,608 - stpipe.Detector1Pipeline - INFO - Prefetch for TRAPPARS reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_trappars_0002.fits'.
2025-09-13 16:13:32,608 - jwst.pipeline.calwebb_detector1 - INFO - Starting calwebb_detector1 ...
2025-09-13 16:13:33,759 - stpipe.Detector1Pipeline.group_scale - INFO - Step group_scale running with args (<RampModel(6, 20, 2048, 2048) from jw02079004003_03101_00003_nis_uncal.fits>,).
2025-09-13 16:13:33,767 - stpipe.Detector1Pipeline.group_scale - INFO - NFRAMES and FRMDIVSR are equal; correction not needed
2025-09-13 16:13:33,767 - stpipe.Detector1Pipeline.group_scale - INFO - Step will be skipped
2025-09-13 16:13:33,769 - stpipe.Detector1Pipeline.group_scale - INFO - Step group_scale done
2025-09-13 16:13:33,947 - stpipe.Detector1Pipeline.dq_init - INFO - Step dq_init running with args (<RampModel(6, 20, 2048, 2048) from jw02079004003_03101_00003_nis_uncal.fits>,).
2025-09-13 16:13:33,957 - stpipe.Detector1Pipeline.dq_init - INFO - Using MASK reference file /home/runner/crds/references/jwst/niriss/jwst_niriss_mask_0035.fits
2025-09-13 16:13:34,873 - stpipe.Detector1Pipeline.dq_init - INFO - Step dq_init done
2025-09-13 16:13:35,060 - stpipe.Detector1Pipeline.saturation - INFO - Step saturation running with args (<RampModel(6, 20, 2048, 2048) from jw02079004003_03101_00003_nis_uncal.fits>,).
2025-09-13 16:13:35,071 - stpipe.Detector1Pipeline.saturation - INFO - Using SATURATION reference file /home/runner/crds/references/jwst/niriss/jwst_niriss_saturation_0015.fits
2025-09-13 16:13:35,071 - stpipe.Detector1Pipeline.saturation - INFO - Using SUPERBIAS reference file /home/runner/crds/references/jwst/niriss/jwst_niriss_superbias_0238.fits
2025-09-13 16:13:35,098 - stdatamodels.dynamicdq - WARNING - Keyword LOWILLUM does not correspond to an existing DQ mnemonic, so will be ignored
2025-09-13 16:13:35,099 - stdatamodels.dynamicdq - WARNING - Keyword LOWRESP does not correspond to an existing DQ mnemonic, so will be ignored
2025-09-13 16:13:35,104 - stdatamodels.dynamicdq - WARNING - Keyword UNCERTAIN does not correspond to an existing DQ mnemonic, so will be ignored
2025-09-13 16:13:35,497 - jwst.saturation.saturation - INFO - Using read_pattern with nframes 4
2025-09-13 16:13:42,638 - stcal.saturation.saturation - INFO - Detected 20681 saturated pixels
2025-09-13 16:13:42,790 - stcal.saturation.saturation - INFO - Detected 4 A/D floor pixels
2025-09-13 16:13:42,797 - stpipe.Detector1Pipeline.saturation - INFO - Step saturation done
2025-09-13 16:13:42,989 - stpipe.Detector1Pipeline.ipc - INFO - Step ipc running with args (<RampModel(6, 20, 2048, 2048) from jw02079004003_03101_00003_nis_uncal.fits>,).
2025-09-13 16:13:42,990 - stpipe.Detector1Pipeline.ipc - INFO - Step skipped.
2025-09-13 16:13:43,173 - stpipe.Detector1Pipeline.superbias - INFO - Step superbias running with args (<RampModel(6, 20, 2048, 2048) from jw02079004003_03101_00003_nis_uncal.fits>,).
2025-09-13 16:13:43,183 - stpipe.Detector1Pipeline.superbias - INFO - Using SUPERBIAS reference file /home/runner/crds/references/jwst/niriss/jwst_niriss_superbias_0238.fits
2025-09-13 16:13:44,925 - stpipe.Detector1Pipeline.superbias - INFO - Step superbias done
2025-09-13 16:13:45,116 - stpipe.Detector1Pipeline.refpix - INFO - Step refpix running with args (<RampModel(6, 20, 2048, 2048) from jw02079004003_03101_00003_nis_uncal.fits>,).
2025-09-13 16:13:45,501 - jwst.refpix.reference_pixels - INFO - NIR full frame data
2025-09-13 16:13:45,502 - jwst.refpix.reference_pixels - INFO - The following parameters are valid for this mode:
2025-09-13 16:13:45,503 - jwst.refpix.reference_pixels - INFO - use_side_ref_pixels = True
2025-09-13 16:13:45,503 - jwst.refpix.reference_pixels - INFO - odd_even_columns = True
2025-09-13 16:13:45,503 - jwst.refpix.reference_pixels - INFO - side_smoothing_length = 11
2025-09-13 16:13:45,504 - jwst.refpix.reference_pixels - INFO - side_gain = 1.0
2025-09-13 16:13:45,504 - jwst.refpix.reference_pixels - INFO - The following parameter is not applicable and is ignored:
2025-09-13 16:13:45,505 - jwst.refpix.reference_pixels - INFO - odd_even_rows = False
2025-09-13 16:14:16,470 - stpipe.Detector1Pipeline.refpix - INFO - Step refpix done
2025-09-13 16:14:16,666 - stpipe.Detector1Pipeline.linearity - INFO - Step linearity running with args (<RampModel(6, 20, 2048, 2048) from jw02079004003_03101_00003_nis_uncal.fits>,).
2025-09-13 16:14:16,676 - stpipe.Detector1Pipeline.linearity - INFO - Using Linearity reference file /home/runner/crds/references/jwst/niriss/jwst_niriss_linearity_0017.fits
2025-09-13 16:14:16,723 - stdatamodels.dynamicdq - WARNING - Keyword LOWILLUM does not correspond to an existing DQ mnemonic, so will be ignored
2025-09-13 16:14:16,724 - stdatamodels.dynamicdq - WARNING - Keyword LOWRESP does not correspond to an existing DQ mnemonic, so will be ignored
2025-09-13 16:14:16,729 - stdatamodels.dynamicdq - WARNING - Keyword UNCERTAIN does not correspond to an existing DQ mnemonic, so will be ignored
2025-09-13 16:14:21,173 - stpipe.Detector1Pipeline.linearity - INFO - Step linearity done
2025-09-13 16:14:21,370 - stpipe.Detector1Pipeline.persistence - INFO - Step persistence running with args (<RampModel(6, 20, 2048, 2048) from jw02079004003_03101_00003_nis_uncal.fits>,).
2025-09-13 16:14:43,965 - stpipe.Detector1Pipeline.persistence - INFO - Saved model in /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage1/jw02079004003_03101_00003_nis_trapsfilled.fits
2025-09-13 16:14:43,968 - stpipe.Detector1Pipeline.persistence - INFO - Step persistence done
2025-09-13 16:14:44,159 - stpipe.Detector1Pipeline.dark_current - INFO - Step dark_current running with args (<RampModel(6, 20, 2048, 2048) from jw02079004003_03101_00003_nis_uncal.fits>,).
2025-09-13 16:14:44,169 - stpipe.Detector1Pipeline.dark_current - INFO - Using DARK reference file /home/runner/crds/references/jwst/niriss/jwst_niriss_dark_0228.fits
2025-09-13 16:14:44,726 - stcal.dark_current.dark_sub - INFO - Science data nints=6, ngroups=20, nframes=4, groupgap=0
2025-09-13 16:14:44,727 - stcal.dark_current.dark_sub - INFO - Dark data nints=1, ngroups=30, nframes=4, groupgap=0
2025-09-13 16:14:45,643 - stpipe.Detector1Pipeline.dark_current - INFO - Step dark_current done
2025-09-13 16:14:45,845 - stpipe.Detector1Pipeline.charge_migration - INFO - Step charge_migration running with args (<RampModel(6, 20, 2048, 2048) from jw02079004003_03101_00003_nis_uncal.fits>,).
2025-09-13 16:14:46,214 - jwst.charge_migration.charge_migration - INFO - Using signal_threshold: 22314.00
2025-09-13 16:14:49,764 - stpipe.Detector1Pipeline.charge_migration - INFO - Step charge_migration done
2025-09-13 16:14:49,956 - stpipe.Detector1Pipeline.jump - INFO - Step jump running with args (<RampModel(6, 20, 2048, 2048) from jw02079004003_03101_00003_nis_uncal.fits>,).
2025-09-13 16:14:49,964 - stpipe.Detector1Pipeline.jump - INFO - CR rejection threshold = 6 sigma
2025-09-13 16:14:49,965 - stpipe.Detector1Pipeline.jump - INFO - Maximum cores to use = 1
2025-09-13 16:14:50,333 - stpipe.Detector1Pipeline.jump - INFO - Using GAIN reference file: /home/runner/crds/references/jwst/niriss/jwst_niriss_gain_0006.fits
2025-09-13 16:14:50,336 - stpipe.Detector1Pipeline.jump - INFO - Using READNOISE reference file: /home/runner/crds/references/jwst/niriss/jwst_niriss_readnoise_0005.fits
2025-09-13 16:14:51,034 - stcal.jump.jump - INFO - Executing two-point difference method
2025-09-13 16:15:19,992 - stcal.jump.jump - INFO - Flagging Snowballs
2025-09-13 16:15:22,542 - stcal.jump.jump - INFO - Total snowballs = 698
2025-09-13 16:15:22,543 - stcal.jump.jump - INFO - Total elapsed time = 31.5081 sec
2025-09-13 16:15:23,046 - stpipe.Detector1Pipeline.jump - INFO - The execution time in seconds: 33.081527
2025-09-13 16:15:23,048 - stpipe.Detector1Pipeline.jump - INFO - Step jump done
2025-09-13 16:15:23,251 - stpipe.Detector1Pipeline.clean_flicker_noise - INFO - Step clean_flicker_noise running with args (<RampModel(6, 20, 2048, 2048) from jw02079004003_03101_00003_nis_uncal.fits>,).
2025-09-13 16:15:23,252 - stpipe.Detector1Pipeline.clean_flicker_noise - INFO - Step skipped.
2025-09-13 16:15:23,434 - stpipe.Detector1Pipeline.ramp_fit - INFO - Step ramp_fit running with args (<RampModel(6, 20, 2048, 2048) from jw02079004003_03101_00003_nis_uncal.fits>,).
2025-09-13 16:15:23,817 - jwst.ramp_fitting.ramp_fit_step - INFO - Using READNOISE reference file: /home/runner/crds/references/jwst/niriss/jwst_niriss_readnoise_0005.fits
2025-09-13 16:15:23,817 - jwst.ramp_fitting.ramp_fit_step - INFO - Using GAIN reference file: /home/runner/crds/references/jwst/niriss/jwst_niriss_gain_0006.fits
2025-09-13 16:15:23,843 - jwst.ramp_fitting.ramp_fit_step - INFO - Using algorithm = OLS_C
2025-09-13 16:15:23,844 - jwst.ramp_fitting.ramp_fit_step - INFO - Using weighting = optimal
2025-09-13 16:15:25,550 - stcal.ramp_fitting.ols_fit - INFO - Number of multiprocessing slices: 1
2025-09-13 16:16:05,824 - stcal.ramp_fitting.ols_fit - INFO - Ramp Fitting C Time: 40.26605463027954
2025-09-13 16:16:05,875 - stpipe.Detector1Pipeline.ramp_fit - INFO - Step ramp_fit done
2025-09-13 16:16:06,073 - stpipe.Detector1Pipeline.gain_scale - INFO - Step gain_scale running with args (<ImageModel(2048, 2048) from jw02079004003_03101_00003_nis_uncal.fits>,).
2025-09-13 16:16:06,094 - stpipe.Detector1Pipeline.gain_scale - INFO - GAINFACT not found in gain reference file
2025-09-13 16:16:06,095 - stpipe.Detector1Pipeline.gain_scale - INFO - Step will be skipped
2025-09-13 16:16:06,097 - stpipe.Detector1Pipeline.gain_scale - INFO - Step gain_scale done
2025-09-13 16:16:06,279 - stpipe.Detector1Pipeline.gain_scale - INFO - Step gain_scale running with args (<CubeModel(6, 2048, 2048) from jw02079004003_03101_00003_nis_uncal.fits>,).
2025-09-13 16:16:06,300 - stpipe.Detector1Pipeline.gain_scale - INFO - GAINFACT not found in gain reference file
2025-09-13 16:16:06,301 - stpipe.Detector1Pipeline.gain_scale - INFO - Step will be skipped
2025-09-13 16:16:06,303 - stpipe.Detector1Pipeline.gain_scale - INFO - Step gain_scale done
2025-09-13 16:16:06,737 - stpipe.Detector1Pipeline - INFO - Saved model in /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage1/jw02079004003_03101_00003_nis_rateints.fits
2025-09-13 16:16:06,738 - jwst.pipeline.calwebb_detector1 - INFO - ... ending calwebb_detector1
2025-09-13 16:16:06,741 - jwst.stpipe.core - INFO - Results used CRDS context: jwst_1413.pmap
2025-09-13 16:16:06,852 - stpipe.Detector1Pipeline - INFO - Saved model in /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage1/jw02079004003_03101_00003_nis_rate.fits
2025-09-13 16:16:06,853 - stpipe.Detector1Pipeline - INFO - Step Detector1Pipeline done
2025-09-13 16:16:06,854 - jwst.stpipe.core - INFO - Results used jwst version: 1.19.1
2025-09-13 16:16:06,884 - CRDS - ERROR - Error determining best reference for 'pars-darkcurrentstep' = No match found.
2025-09-13 16:16:06,887 - stpipe - INFO - PARS-CHARGEMIGRATIONSTEP parameters found: /home/runner/crds/references/jwst/niriss/jwst_niriss_pars-chargemigrationstep_0016.asdf
2025-09-13 16:16:06,895 - stpipe - INFO - PARS-JUMPSTEP parameters found: /home/runner/crds/references/jwst/niriss/jwst_niriss_pars-jumpstep_0085.asdf
2025-09-13 16:16:06,906 - stpipe - INFO - PARS-DETECTOR1PIPELINE parameters found: /home/runner/crds/references/jwst/niriss/jwst_niriss_pars-detector1pipeline_0001.asdf
2025-09-13 16:16:06,922 - stpipe.Detector1Pipeline - INFO - Detector1Pipeline instance created.
2025-09-13 16:16:06,923 - stpipe.Detector1Pipeline.group_scale - INFO - GroupScaleStep instance created.
2025-09-13 16:16:06,924 - stpipe.Detector1Pipeline.dq_init - INFO - DQInitStep instance created.
2025-09-13 16:16:06,924 - stpipe.Detector1Pipeline.emicorr - INFO - EmiCorrStep instance created.
2025-09-13 16:16:06,925 - stpipe.Detector1Pipeline.saturation - INFO - SaturationStep instance created.
2025-09-13 16:16:06,926 - stpipe.Detector1Pipeline.ipc - INFO - IPCStep instance created.
2025-09-13 16:16:06,927 - stpipe.Detector1Pipeline.superbias - INFO - SuperBiasStep instance created.
2025-09-13 16:16:06,928 - stpipe.Detector1Pipeline.refpix - INFO - RefPixStep instance created.
2025-09-13 16:16:06,929 - stpipe.Detector1Pipeline.rscd - INFO - RscdStep instance created.
2025-09-13 16:16:06,930 - stpipe.Detector1Pipeline.firstframe - INFO - FirstFrameStep instance created.
2025-09-13 16:16:06,930 - stpipe.Detector1Pipeline.lastframe - INFO - LastFrameStep instance created.
2025-09-13 16:16:06,931 - stpipe.Detector1Pipeline.linearity - INFO - LinearityStep instance created.
2025-09-13 16:16:06,932 - stpipe.Detector1Pipeline.dark_current - INFO - DarkCurrentStep instance created.
2025-09-13 16:16:06,933 - stpipe.Detector1Pipeline.reset - INFO - ResetStep instance created.
2025-09-13 16:16:06,934 - stpipe.Detector1Pipeline.persistence - INFO - PersistenceStep instance created.
2025-09-13 16:16:06,935 - stpipe.Detector1Pipeline.charge_migration - INFO - ChargeMigrationStep instance created.
2025-09-13 16:16:06,936 - stpipe.Detector1Pipeline.jump - INFO - JumpStep instance created.
2025-09-13 16:16:06,939 - stpipe.Detector1Pipeline.clean_flicker_noise - INFO - CleanFlickerNoiseStep instance created.
2025-09-13 16:16:06,940 - stpipe.Detector1Pipeline.ramp_fit - INFO - RampFitStep instance created.
2025-09-13 16:16:06,940 - stpipe.Detector1Pipeline.gain_scale - INFO - GainScaleStep instance created.
2025-09-13 16:16:07,122 - stpipe.Detector1Pipeline - INFO - Step Detector1Pipeline running with args ('/home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/uncal/jw02079004003_04101_00001_nis_uncal.fits',).
2025-09-13 16:16:07,143 - stpipe.Detector1Pipeline - INFO - Step Detector1Pipeline parameters are:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage1
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: True
skip: False
suffix: None
search_output_file: True
input_dir: ''
save_calibrated_ramp: False
steps:
group_scale:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
dq_init:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
emicorr:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: True
suffix: None
search_output_file: True
input_dir: ''
algorithm: joint
nints_to_phase: None
nbins: None
scale_reference: True
onthefly_corr_freq: None
use_n_cycles: 3
fit_ints_separately: False
user_supplied_reffile: None
save_intermediate_results: False
saturation:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
n_pix_grow_sat: 1
use_readpatt: True
ipc:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: True
suffix: None
search_output_file: True
input_dir: ''
superbias:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
refpix:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
odd_even_columns: True
use_side_ref_pixels: True
side_smoothing_length: 11
side_gain: 1.0
odd_even_rows: True
ovr_corr_mitigation_ftr: 3.0
preserve_irs2_refpix: False
irs2_mean_subtraction: False
refpix_algorithm: median
sigreject: 4.0
gaussmooth: 1.0
halfwidth: 30
rscd:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
firstframe:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
bright_use_group1: False
lastframe:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
linearity:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
dark_current:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
dark_output: None
average_dark_current: None
reset:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
persistence:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
input_trapsfilled: ''
flag_pers_cutoff: 40.0
save_persistence: False
save_trapsfilled: True
modify_input: False
charge_migration:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
signal_threshold: 22314.0
jump:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
rejection_threshold: 4.0
three_group_rejection_threshold: 6.0
four_group_rejection_threshold: 5.0
maximum_cores: '1'
flag_4_neighbors: False
max_jump_to_flag_neighbors: 200.0
min_jump_to_flag_neighbors: 10.0
after_jump_flag_dn1: 1000
after_jump_flag_time1: 90
after_jump_flag_dn2: 0
after_jump_flag_time2: 0
expand_large_events: True
min_sat_area: 5
min_jump_area: 15.0
expand_factor: 1.75
use_ellipses: False
sat_required_snowball: True
min_sat_radius_extend: 5.0
sat_expand: 0
edge_size: 20
mask_snowball_core_next_int: True
snowball_time_masked_next_int: 4000
find_showers: False
max_shower_amplitude: 4.0
extend_snr_threshold: 1.2
extend_min_area: 90
extend_inner_radius: 1.0
extend_outer_radius: 2.6
extend_ellipse_expand_ratio: 1.1
time_masked_after_shower: 15.0
min_diffs_single_pass: 10
max_extended_radius: 100
minimum_groups: 3
minimum_sigclip_groups: 100
only_use_ints: True
clean_flicker_noise:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: True
suffix: None
search_output_file: True
input_dir: ''
fit_method: median
fit_by_channel: False
background_method: median
background_box_size: None
mask_science_regions: False
apply_flat_field: False
n_sigma: 2.0
fit_histogram: False
single_mask: True
user_mask: None
save_mask: False
save_background: False
save_noise: False
ramp_fit:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
algorithm: OLS_C
int_name: ''
save_opt: False
opt_name: ''
suppress_one_group: True
firstgroup: None
lastgroup: None
maximum_cores: '1'
gain_scale:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
2025-09-13 16:16:07,163 - stpipe.Detector1Pipeline - INFO - Prefetching reference files for dataset: 'jw02079004003_04101_00001_nis_uncal.fits' reftypes = ['dark', 'gain', 'linearity', 'mask', 'persat', 'readnoise', 'refpix', 'reset', 'rscd', 'saturation', 'sirskernel', 'superbias', 'trapdensity', 'trappars']
2025-09-13 16:16:07,166 - stpipe.Detector1Pipeline - INFO - Prefetch for DARK reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_dark_0228.fits'.
2025-09-13 16:16:07,167 - stpipe.Detector1Pipeline - INFO - Prefetch for GAIN reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_gain_0006.fits'.
2025-09-13 16:16:07,167 - stpipe.Detector1Pipeline - INFO - Prefetch for LINEARITY reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_linearity_0017.fits'.
2025-09-13 16:16:07,167 - stpipe.Detector1Pipeline - INFO - Prefetch for MASK reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_mask_0035.fits'.
2025-09-13 16:16:07,168 - stpipe.Detector1Pipeline - INFO - Prefetch for PERSAT reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_persat_0004.fits'.
2025-09-13 16:16:07,168 - stpipe.Detector1Pipeline - INFO - Prefetch for READNOISE reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_readnoise_0005.fits'.
2025-09-13 16:16:07,169 - stpipe.Detector1Pipeline - INFO - Prefetch for REFPIX reference file is 'N/A'.
2025-09-13 16:16:07,169 - stpipe.Detector1Pipeline - INFO - Prefetch for RESET reference file is 'N/A'.
2025-09-13 16:16:07,170 - stpipe.Detector1Pipeline - INFO - Prefetch for RSCD reference file is 'N/A'.
2025-09-13 16:16:07,170 - stpipe.Detector1Pipeline - INFO - Prefetch for SATURATION reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_saturation_0015.fits'.
2025-09-13 16:16:07,170 - stpipe.Detector1Pipeline - INFO - Prefetch for SIRSKERNEL reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_sirskernel_0001.asdf'.
2025-09-13 16:16:07,171 - stpipe.Detector1Pipeline - INFO - Prefetch for SUPERBIAS reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_superbias_0238.fits'.
2025-09-13 16:16:07,173 - stpipe.Detector1Pipeline - INFO - Prefetch for TRAPDENSITY reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_trapdensity_0002.fits'.
2025-09-13 16:16:07,173 - stpipe.Detector1Pipeline - INFO - Prefetch for TRAPPARS reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_trappars_0002.fits'.
2025-09-13 16:16:07,174 - jwst.pipeline.calwebb_detector1 - INFO - Starting calwebb_detector1 ...
2025-09-13 16:16:07,471 - stpipe.Detector1Pipeline.group_scale - INFO - Step group_scale running with args (<RampModel(1, 5, 2048, 2048) from jw02079004003_04101_00001_nis_uncal.fits>,).
2025-09-13 16:16:07,479 - stpipe.Detector1Pipeline.group_scale - INFO - NFRAMES and FRMDIVSR are equal; correction not needed
2025-09-13 16:16:07,480 - stpipe.Detector1Pipeline.group_scale - INFO - Step will be skipped
2025-09-13 16:16:07,481 - stpipe.Detector1Pipeline.group_scale - INFO - Step group_scale done
2025-09-13 16:16:07,658 - stpipe.Detector1Pipeline.dq_init - INFO - Step dq_init running with args (<RampModel(1, 5, 2048, 2048) from jw02079004003_04101_00001_nis_uncal.fits>,).
2025-09-13 16:16:07,667 - stpipe.Detector1Pipeline.dq_init - INFO - Using MASK reference file /home/runner/crds/references/jwst/niriss/jwst_niriss_mask_0035.fits
2025-09-13 16:16:07,813 - stpipe.Detector1Pipeline.dq_init - INFO - Step dq_init done
2025-09-13 16:16:07,996 - stpipe.Detector1Pipeline.saturation - INFO - Step saturation running with args (<RampModel(1, 5, 2048, 2048) from jw02079004003_04101_00001_nis_uncal.fits>,).
2025-09-13 16:16:08,006 - stpipe.Detector1Pipeline.saturation - INFO - Using SATURATION reference file /home/runner/crds/references/jwst/niriss/jwst_niriss_saturation_0015.fits
2025-09-13 16:16:08,007 - stpipe.Detector1Pipeline.saturation - INFO - Using SUPERBIAS reference file /home/runner/crds/references/jwst/niriss/jwst_niriss_superbias_0238.fits
2025-09-13 16:16:08,034 - stdatamodels.dynamicdq - WARNING - Keyword LOWILLUM does not correspond to an existing DQ mnemonic, so will be ignored
2025-09-13 16:16:08,035 - stdatamodels.dynamicdq - WARNING - Keyword LOWRESP does not correspond to an existing DQ mnemonic, so will be ignored
2025-09-13 16:16:08,040 - stdatamodels.dynamicdq - WARNING - Keyword UNCERTAIN does not correspond to an existing DQ mnemonic, so will be ignored
2025-09-13 16:16:08,101 - jwst.saturation.saturation - INFO - Using read_pattern with nframes 4
2025-09-13 16:16:08,480 - stcal.saturation.saturation - INFO - Detected 908 saturated pixels
2025-09-13 16:16:08,489 - stcal.saturation.saturation - INFO - Detected 1 A/D floor pixels
2025-09-13 16:16:08,496 - stpipe.Detector1Pipeline.saturation - INFO - Step saturation done
2025-09-13 16:16:08,685 - stpipe.Detector1Pipeline.ipc - INFO - Step ipc running with args (<RampModel(1, 5, 2048, 2048) from jw02079004003_04101_00001_nis_uncal.fits>,).
2025-09-13 16:16:08,686 - stpipe.Detector1Pipeline.ipc - INFO - Step skipped.
2025-09-13 16:16:08,867 - stpipe.Detector1Pipeline.superbias - INFO - Step superbias running with args (<RampModel(1, 5, 2048, 2048) from jw02079004003_04101_00001_nis_uncal.fits>,).
2025-09-13 16:16:08,877 - stpipe.Detector1Pipeline.superbias - INFO - Using SUPERBIAS reference file /home/runner/crds/references/jwst/niriss/jwst_niriss_superbias_0238.fits
2025-09-13 16:16:09,008 - stpipe.Detector1Pipeline.superbias - INFO - Step superbias done
2025-09-13 16:16:09,196 - stpipe.Detector1Pipeline.refpix - INFO - Step refpix running with args (<RampModel(1, 5, 2048, 2048) from jw02079004003_04101_00001_nis_uncal.fits>,).
2025-09-13 16:16:09,221 - jwst.refpix.reference_pixels - INFO - NIR full frame data
2025-09-13 16:16:09,222 - jwst.refpix.reference_pixels - INFO - The following parameters are valid for this mode:
2025-09-13 16:16:09,223 - jwst.refpix.reference_pixels - INFO - use_side_ref_pixels = True
2025-09-13 16:16:09,223 - jwst.refpix.reference_pixels - INFO - odd_even_columns = True
2025-09-13 16:16:09,224 - jwst.refpix.reference_pixels - INFO - side_smoothing_length = 11
2025-09-13 16:16:09,224 - jwst.refpix.reference_pixels - INFO - side_gain = 1.0
2025-09-13 16:16:09,225 - jwst.refpix.reference_pixels - INFO - The following parameter is not applicable and is ignored:
2025-09-13 16:16:09,225 - jwst.refpix.reference_pixels - INFO - odd_even_rows = False
2025-09-13 16:16:10,529 - stpipe.Detector1Pipeline.refpix - INFO - Step refpix done
2025-09-13 16:16:10,716 - stpipe.Detector1Pipeline.linearity - INFO - Step linearity running with args (<RampModel(1, 5, 2048, 2048) from jw02079004003_04101_00001_nis_uncal.fits>,).
2025-09-13 16:16:10,726 - stpipe.Detector1Pipeline.linearity - INFO - Using Linearity reference file /home/runner/crds/references/jwst/niriss/jwst_niriss_linearity_0017.fits
2025-09-13 16:16:10,780 - stdatamodels.dynamicdq - WARNING - Keyword LOWILLUM does not correspond to an existing DQ mnemonic, so will be ignored
2025-09-13 16:16:10,781 - stdatamodels.dynamicdq - WARNING - Keyword LOWRESP does not correspond to an existing DQ mnemonic, so will be ignored
2025-09-13 16:16:10,785 - stdatamodels.dynamicdq - WARNING - Keyword UNCERTAIN does not correspond to an existing DQ mnemonic, so will be ignored
2025-09-13 16:16:11,092 - stpipe.Detector1Pipeline.linearity - INFO - Step linearity done
2025-09-13 16:16:11,274 - stpipe.Detector1Pipeline.persistence - INFO - Step persistence running with args (<RampModel(1, 5, 2048, 2048) from jw02079004003_04101_00001_nis_uncal.fits>,).
2025-09-13 16:16:12,671 - stpipe.Detector1Pipeline.persistence - INFO - Saved model in /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage1/jw02079004003_04101_00001_nis_trapsfilled.fits
2025-09-13 16:16:12,675 - stpipe.Detector1Pipeline.persistence - INFO - Step persistence done
2025-09-13 16:16:12,864 - stpipe.Detector1Pipeline.dark_current - INFO - Step dark_current running with args (<RampModel(1, 5, 2048, 2048) from jw02079004003_04101_00001_nis_uncal.fits>,).
2025-09-13 16:16:12,874 - stpipe.Detector1Pipeline.dark_current - INFO - Using DARK reference file /home/runner/crds/references/jwst/niriss/jwst_niriss_dark_0228.fits
2025-09-13 16:16:13,097 - stcal.dark_current.dark_sub - INFO - Science data nints=1, ngroups=5, nframes=4, groupgap=0
2025-09-13 16:16:13,098 - stcal.dark_current.dark_sub - INFO - Dark data nints=1, ngroups=30, nframes=4, groupgap=0
2025-09-13 16:16:13,248 - stpipe.Detector1Pipeline.dark_current - INFO - Step dark_current done
2025-09-13 16:16:13,438 - stpipe.Detector1Pipeline.charge_migration - INFO - Step charge_migration running with args (<RampModel(1, 5, 2048, 2048) from jw02079004003_04101_00001_nis_uncal.fits>,).
2025-09-13 16:16:13,463 - jwst.charge_migration.charge_migration - INFO - Using signal_threshold: 22314.00
2025-09-13 16:16:13,547 - stpipe.Detector1Pipeline.charge_migration - INFO - Step charge_migration done
2025-09-13 16:16:13,734 - stpipe.Detector1Pipeline.jump - INFO - Step jump running with args (<RampModel(1, 5, 2048, 2048) from jw02079004003_04101_00001_nis_uncal.fits>,).
2025-09-13 16:16:13,741 - stpipe.Detector1Pipeline.jump - INFO - CR rejection threshold = 4 sigma
2025-09-13 16:16:13,742 - stpipe.Detector1Pipeline.jump - INFO - Maximum cores to use = 1
2025-09-13 16:16:13,769 - stpipe.Detector1Pipeline.jump - INFO - Using GAIN reference file: /home/runner/crds/references/jwst/niriss/jwst_niriss_gain_0006.fits
2025-09-13 16:16:13,772 - stpipe.Detector1Pipeline.jump - INFO - Using READNOISE reference file: /home/runner/crds/references/jwst/niriss/jwst_niriss_readnoise_0005.fits
2025-09-13 16:16:13,887 - stcal.jump.jump - INFO - Executing two-point difference method
2025-09-13 16:16:17,110 - stcal.jump.jump - INFO - Flagging Snowballs
2025-09-13 16:16:17,267 - stcal.jump.jump - INFO - Total snowballs = 22
2025-09-13 16:16:17,268 - stcal.jump.jump - INFO - Total elapsed time = 3.38039 sec
2025-09-13 16:16:17,295 - stpipe.Detector1Pipeline.jump - INFO - The execution time in seconds: 3.553655
2025-09-13 16:16:17,298 - stpipe.Detector1Pipeline.jump - INFO - Step jump done
2025-09-13 16:16:17,478 - stpipe.Detector1Pipeline.clean_flicker_noise - INFO - Step clean_flicker_noise running with args (<RampModel(1, 5, 2048, 2048) from jw02079004003_04101_00001_nis_uncal.fits>,).
2025-09-13 16:16:17,479 - stpipe.Detector1Pipeline.clean_flicker_noise - INFO - Step skipped.
2025-09-13 16:16:17,659 - stpipe.Detector1Pipeline.ramp_fit - INFO - Step ramp_fit running with args (<RampModel(1, 5, 2048, 2048) from jw02079004003_04101_00001_nis_uncal.fits>,).
2025-09-13 16:16:17,687 - jwst.ramp_fitting.ramp_fit_step - INFO - Using READNOISE reference file: /home/runner/crds/references/jwst/niriss/jwst_niriss_readnoise_0005.fits
2025-09-13 16:16:17,688 - jwst.ramp_fitting.ramp_fit_step - INFO - Using GAIN reference file: /home/runner/crds/references/jwst/niriss/jwst_niriss_gain_0006.fits
2025-09-13 16:16:17,714 - jwst.ramp_fitting.ramp_fit_step - INFO - Using algorithm = OLS_C
2025-09-13 16:16:17,715 - jwst.ramp_fitting.ramp_fit_step - INFO - Using weighting = optimal
2025-09-13 16:16:17,820 - stcal.ramp_fitting.ols_fit - INFO - Number of multiprocessing slices: 1
2025-09-13 16:16:19,658 - stcal.ramp_fitting.ols_fit - INFO - Ramp Fitting C Time: 1.8340275287628174
2025-09-13 16:16:19,703 - stpipe.Detector1Pipeline.ramp_fit - INFO - Step ramp_fit done
2025-09-13 16:16:19,886 - stpipe.Detector1Pipeline.gain_scale - INFO - Step gain_scale running with args (<ImageModel(2048, 2048) from jw02079004003_04101_00001_nis_uncal.fits>,).
2025-09-13 16:16:19,906 - stpipe.Detector1Pipeline.gain_scale - INFO - GAINFACT not found in gain reference file
2025-09-13 16:16:19,907 - stpipe.Detector1Pipeline.gain_scale - INFO - Step will be skipped
2025-09-13 16:16:19,909 - stpipe.Detector1Pipeline.gain_scale - INFO - Step gain_scale done
2025-09-13 16:16:20,090 - stpipe.Detector1Pipeline.gain_scale - INFO - Step gain_scale running with args (<CubeModel(1, 2048, 2048) from jw02079004003_04101_00001_nis_uncal.fits>,).
2025-09-13 16:16:20,111 - stpipe.Detector1Pipeline.gain_scale - INFO - GAINFACT not found in gain reference file
2025-09-13 16:16:20,112 - stpipe.Detector1Pipeline.gain_scale - INFO - Step will be skipped
2025-09-13 16:16:20,114 - stpipe.Detector1Pipeline.gain_scale - INFO - Step gain_scale done
2025-09-13 16:16:20,229 - stpipe.Detector1Pipeline - INFO - Saved model in /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage1/jw02079004003_04101_00001_nis_rateints.fits
2025-09-13 16:16:20,230 - jwst.pipeline.calwebb_detector1 - INFO - ... ending calwebb_detector1
2025-09-13 16:16:20,232 - jwst.stpipe.core - INFO - Results used CRDS context: jwst_1413.pmap
2025-09-13 16:16:20,346 - stpipe.Detector1Pipeline - INFO - Saved model in /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage1/jw02079004003_04101_00001_nis_rate.fits
2025-09-13 16:16:20,346 - stpipe.Detector1Pipeline - INFO - Step Detector1Pipeline done
2025-09-13 16:16:20,347 - jwst.stpipe.core - INFO - Results used jwst version: 1.19.1
2025-09-13 16:16:20,377 - CRDS - ERROR - Error determining best reference for 'pars-darkcurrentstep' = No match found.
2025-09-13 16:16:20,381 - stpipe - INFO - PARS-CHARGEMIGRATIONSTEP parameters found: /home/runner/crds/references/jwst/niriss/jwst_niriss_pars-chargemigrationstep_0016.asdf
2025-09-13 16:16:20,389 - stpipe - INFO - PARS-JUMPSTEP parameters found: /home/runner/crds/references/jwst/niriss/jwst_niriss_pars-jumpstep_0085.asdf
2025-09-13 16:16:20,400 - stpipe - INFO - PARS-DETECTOR1PIPELINE parameters found: /home/runner/crds/references/jwst/niriss/jwst_niriss_pars-detector1pipeline_0001.asdf
2025-09-13 16:16:20,416 - stpipe.Detector1Pipeline - INFO - Detector1Pipeline instance created.
2025-09-13 16:16:20,417 - stpipe.Detector1Pipeline.group_scale - INFO - GroupScaleStep instance created.
2025-09-13 16:16:20,418 - stpipe.Detector1Pipeline.dq_init - INFO - DQInitStep instance created.
2025-09-13 16:16:20,419 - stpipe.Detector1Pipeline.emicorr - INFO - EmiCorrStep instance created.
2025-09-13 16:16:20,419 - stpipe.Detector1Pipeline.saturation - INFO - SaturationStep instance created.
2025-09-13 16:16:20,420 - stpipe.Detector1Pipeline.ipc - INFO - IPCStep instance created.
2025-09-13 16:16:20,421 - stpipe.Detector1Pipeline.superbias - INFO - SuperBiasStep instance created.
2025-09-13 16:16:20,422 - stpipe.Detector1Pipeline.refpix - INFO - RefPixStep instance created.
2025-09-13 16:16:20,423 - stpipe.Detector1Pipeline.rscd - INFO - RscdStep instance created.
2025-09-13 16:16:20,424 - stpipe.Detector1Pipeline.firstframe - INFO - FirstFrameStep instance created.
2025-09-13 16:16:20,424 - stpipe.Detector1Pipeline.lastframe - INFO - LastFrameStep instance created.
2025-09-13 16:16:20,425 - stpipe.Detector1Pipeline.linearity - INFO - LinearityStep instance created.
2025-09-13 16:16:20,426 - stpipe.Detector1Pipeline.dark_current - INFO - DarkCurrentStep instance created.
2025-09-13 16:16:20,427 - stpipe.Detector1Pipeline.reset - INFO - ResetStep instance created.
2025-09-13 16:16:20,428 - stpipe.Detector1Pipeline.persistence - INFO - PersistenceStep instance created.
2025-09-13 16:16:20,428 - stpipe.Detector1Pipeline.charge_migration - INFO - ChargeMigrationStep instance created.
2025-09-13 16:16:20,430 - stpipe.Detector1Pipeline.jump - INFO - JumpStep instance created.
2025-09-13 16:16:20,431 - stpipe.Detector1Pipeline.clean_flicker_noise - INFO - CleanFlickerNoiseStep instance created.
2025-09-13 16:16:20,432 - stpipe.Detector1Pipeline.ramp_fit - INFO - RampFitStep instance created.
2025-09-13 16:16:20,433 - stpipe.Detector1Pipeline.gain_scale - INFO - GainScaleStep instance created.
2025-09-13 16:16:20,615 - stpipe.Detector1Pipeline - INFO - Step Detector1Pipeline running with args ('/home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/uncal/jw02079004003_04101_00002_nis_uncal.fits',).
2025-09-13 16:16:20,636 - stpipe.Detector1Pipeline - INFO - Step Detector1Pipeline parameters are:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage1
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: True
skip: False
suffix: None
search_output_file: True
input_dir: ''
save_calibrated_ramp: False
steps:
group_scale:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
dq_init:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
emicorr:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: True
suffix: None
search_output_file: True
input_dir: ''
algorithm: joint
nints_to_phase: None
nbins: None
scale_reference: True
onthefly_corr_freq: None
use_n_cycles: 3
fit_ints_separately: False
user_supplied_reffile: None
save_intermediate_results: False
saturation:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
n_pix_grow_sat: 1
use_readpatt: True
ipc:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: True
suffix: None
search_output_file: True
input_dir: ''
superbias:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
refpix:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
odd_even_columns: True
use_side_ref_pixels: True
side_smoothing_length: 11
side_gain: 1.0
odd_even_rows: True
ovr_corr_mitigation_ftr: 3.0
preserve_irs2_refpix: False
irs2_mean_subtraction: False
refpix_algorithm: median
sigreject: 4.0
gaussmooth: 1.0
halfwidth: 30
rscd:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
firstframe:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
bright_use_group1: False
lastframe:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
linearity:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
dark_current:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
dark_output: None
average_dark_current: None
reset:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
persistence:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
input_trapsfilled: ''
flag_pers_cutoff: 40.0
save_persistence: False
save_trapsfilled: True
modify_input: False
charge_migration:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
signal_threshold: 22314.0
jump:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
rejection_threshold: 4.0
three_group_rejection_threshold: 6.0
four_group_rejection_threshold: 5.0
maximum_cores: '1'
flag_4_neighbors: False
max_jump_to_flag_neighbors: 200.0
min_jump_to_flag_neighbors: 10.0
after_jump_flag_dn1: 1000
after_jump_flag_time1: 90
after_jump_flag_dn2: 0
after_jump_flag_time2: 0
expand_large_events: True
min_sat_area: 5
min_jump_area: 15.0
expand_factor: 1.75
use_ellipses: False
sat_required_snowball: True
min_sat_radius_extend: 5.0
sat_expand: 0
edge_size: 20
mask_snowball_core_next_int: True
snowball_time_masked_next_int: 4000
find_showers: False
max_shower_amplitude: 4.0
extend_snr_threshold: 1.2
extend_min_area: 90
extend_inner_radius: 1.0
extend_outer_radius: 2.6
extend_ellipse_expand_ratio: 1.1
time_masked_after_shower: 15.0
min_diffs_single_pass: 10
max_extended_radius: 100
minimum_groups: 3
minimum_sigclip_groups: 100
only_use_ints: True
clean_flicker_noise:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: True
suffix: None
search_output_file: True
input_dir: ''
fit_method: median
fit_by_channel: False
background_method: median
background_box_size: None
mask_science_regions: False
apply_flat_field: False
n_sigma: 2.0
fit_histogram: False
single_mask: True
user_mask: None
save_mask: False
save_background: False
save_noise: False
ramp_fit:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
algorithm: OLS_C
int_name: ''
save_opt: False
opt_name: ''
suppress_one_group: True
firstgroup: None
lastgroup: None
maximum_cores: '1'
gain_scale:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
2025-09-13 16:16:20,657 - stpipe.Detector1Pipeline - INFO - Prefetching reference files for dataset: 'jw02079004003_04101_00002_nis_uncal.fits' reftypes = ['dark', 'gain', 'linearity', 'mask', 'persat', 'readnoise', 'refpix', 'reset', 'rscd', 'saturation', 'sirskernel', 'superbias', 'trapdensity', 'trappars']
2025-09-13 16:16:20,659 - stpipe.Detector1Pipeline - INFO - Prefetch for DARK reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_dark_0228.fits'.
2025-09-13 16:16:20,660 - stpipe.Detector1Pipeline - INFO - Prefetch for GAIN reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_gain_0006.fits'.
2025-09-13 16:16:20,661 - stpipe.Detector1Pipeline - INFO - Prefetch for LINEARITY reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_linearity_0017.fits'.
2025-09-13 16:16:20,662 - stpipe.Detector1Pipeline - INFO - Prefetch for MASK reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_mask_0035.fits'.
2025-09-13 16:16:20,662 - stpipe.Detector1Pipeline - INFO - Prefetch for PERSAT reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_persat_0004.fits'.
2025-09-13 16:16:20,662 - stpipe.Detector1Pipeline - INFO - Prefetch for READNOISE reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_readnoise_0005.fits'.
2025-09-13 16:16:20,663 - stpipe.Detector1Pipeline - INFO - Prefetch for REFPIX reference file is 'N/A'.
2025-09-13 16:16:20,663 - stpipe.Detector1Pipeline - INFO - Prefetch for RESET reference file is 'N/A'.
2025-09-13 16:16:20,664 - stpipe.Detector1Pipeline - INFO - Prefetch for RSCD reference file is 'N/A'.
2025-09-13 16:16:20,664 - stpipe.Detector1Pipeline - INFO - Prefetch for SATURATION reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_saturation_0015.fits'.
2025-09-13 16:16:20,664 - stpipe.Detector1Pipeline - INFO - Prefetch for SIRSKERNEL reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_sirskernel_0001.asdf'.
2025-09-13 16:16:20,665 - stpipe.Detector1Pipeline - INFO - Prefetch for SUPERBIAS reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_superbias_0238.fits'.
2025-09-13 16:16:20,665 - stpipe.Detector1Pipeline - INFO - Prefetch for TRAPDENSITY reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_trapdensity_0002.fits'.
2025-09-13 16:16:20,666 - stpipe.Detector1Pipeline - INFO - Prefetch for TRAPPARS reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_trappars_0002.fits'.
2025-09-13 16:16:20,666 - jwst.pipeline.calwebb_detector1 - INFO - Starting calwebb_detector1 ...
2025-09-13 16:16:20,971 - stpipe.Detector1Pipeline.group_scale - INFO - Step group_scale running with args (<RampModel(1, 5, 2048, 2048) from jw02079004003_04101_00002_nis_uncal.fits>,).
2025-09-13 16:16:20,978 - stpipe.Detector1Pipeline.group_scale - INFO - NFRAMES and FRMDIVSR are equal; correction not needed
2025-09-13 16:16:20,979 - stpipe.Detector1Pipeline.group_scale - INFO - Step will be skipped
2025-09-13 16:16:20,981 - stpipe.Detector1Pipeline.group_scale - INFO - Step group_scale done
2025-09-13 16:16:21,161 - stpipe.Detector1Pipeline.dq_init - INFO - Step dq_init running with args (<RampModel(1, 5, 2048, 2048) from jw02079004003_04101_00002_nis_uncal.fits>,).
2025-09-13 16:16:21,170 - stpipe.Detector1Pipeline.dq_init - INFO - Using MASK reference file /home/runner/crds/references/jwst/niriss/jwst_niriss_mask_0035.fits
2025-09-13 16:16:21,309 - stpipe.Detector1Pipeline.dq_init - INFO - Step dq_init done
2025-09-13 16:16:21,487 - stpipe.Detector1Pipeline.saturation - INFO - Step saturation running with args (<RampModel(1, 5, 2048, 2048) from jw02079004003_04101_00002_nis_uncal.fits>,).
2025-09-13 16:16:21,498 - stpipe.Detector1Pipeline.saturation - INFO - Using SATURATION reference file /home/runner/crds/references/jwst/niriss/jwst_niriss_saturation_0015.fits
2025-09-13 16:16:21,498 - stpipe.Detector1Pipeline.saturation - INFO - Using SUPERBIAS reference file /home/runner/crds/references/jwst/niriss/jwst_niriss_superbias_0238.fits
2025-09-13 16:16:21,525 - stdatamodels.dynamicdq - WARNING - Keyword LOWILLUM does not correspond to an existing DQ mnemonic, so will be ignored
2025-09-13 16:16:21,526 - stdatamodels.dynamicdq - WARNING - Keyword LOWRESP does not correspond to an existing DQ mnemonic, so will be ignored
2025-09-13 16:16:21,530 - stdatamodels.dynamicdq - WARNING - Keyword UNCERTAIN does not correspond to an existing DQ mnemonic, so will be ignored
2025-09-13 16:16:21,594 - jwst.saturation.saturation - INFO - Using read_pattern with nframes 4
2025-09-13 16:16:21,973 - stcal.saturation.saturation - INFO - Detected 1395 saturated pixels
2025-09-13 16:16:21,981 - stcal.saturation.saturation - INFO - Detected 1 A/D floor pixels
2025-09-13 16:16:21,988 - stpipe.Detector1Pipeline.saturation - INFO - Step saturation done
2025-09-13 16:16:22,168 - stpipe.Detector1Pipeline.ipc - INFO - Step ipc running with args (<RampModel(1, 5, 2048, 2048) from jw02079004003_04101_00002_nis_uncal.fits>,).
2025-09-13 16:16:22,169 - stpipe.Detector1Pipeline.ipc - INFO - Step skipped.
2025-09-13 16:16:22,348 - stpipe.Detector1Pipeline.superbias - INFO - Step superbias running with args (<RampModel(1, 5, 2048, 2048) from jw02079004003_04101_00002_nis_uncal.fits>,).
2025-09-13 16:16:22,357 - stpipe.Detector1Pipeline.superbias - INFO - Using SUPERBIAS reference file /home/runner/crds/references/jwst/niriss/jwst_niriss_superbias_0238.fits
2025-09-13 16:16:22,473 - stpipe.Detector1Pipeline.superbias - INFO - Step superbias done
2025-09-13 16:16:22,653 - stpipe.Detector1Pipeline.refpix - INFO - Step refpix running with args (<RampModel(1, 5, 2048, 2048) from jw02079004003_04101_00002_nis_uncal.fits>,).
2025-09-13 16:16:22,679 - jwst.refpix.reference_pixels - INFO - NIR full frame data
2025-09-13 16:16:22,679 - jwst.refpix.reference_pixels - INFO - The following parameters are valid for this mode:
2025-09-13 16:16:22,680 - jwst.refpix.reference_pixels - INFO - use_side_ref_pixels = True
2025-09-13 16:16:22,680 - jwst.refpix.reference_pixels - INFO - odd_even_columns = True
2025-09-13 16:16:22,681 - jwst.refpix.reference_pixels - INFO - side_smoothing_length = 11
2025-09-13 16:16:22,681 - jwst.refpix.reference_pixels - INFO - side_gain = 1.0
2025-09-13 16:16:22,681 - jwst.refpix.reference_pixels - INFO - The following parameter is not applicable and is ignored:
2025-09-13 16:16:22,682 - jwst.refpix.reference_pixels - INFO - odd_even_rows = False
2025-09-13 16:16:23,965 - stpipe.Detector1Pipeline.refpix - INFO - Step refpix done
2025-09-13 16:16:24,145 - stpipe.Detector1Pipeline.linearity - INFO - Step linearity running with args (<RampModel(1, 5, 2048, 2048) from jw02079004003_04101_00002_nis_uncal.fits>,).
2025-09-13 16:16:24,154 - stpipe.Detector1Pipeline.linearity - INFO - Using Linearity reference file /home/runner/crds/references/jwst/niriss/jwst_niriss_linearity_0017.fits
2025-09-13 16:16:24,200 - stdatamodels.dynamicdq - WARNING - Keyword LOWILLUM does not correspond to an existing DQ mnemonic, so will be ignored
2025-09-13 16:16:24,201 - stdatamodels.dynamicdq - WARNING - Keyword LOWRESP does not correspond to an existing DQ mnemonic, so will be ignored
2025-09-13 16:16:24,205 - stdatamodels.dynamicdq - WARNING - Keyword UNCERTAIN does not correspond to an existing DQ mnemonic, so will be ignored
2025-09-13 16:16:24,509 - stpipe.Detector1Pipeline.linearity - INFO - Step linearity done
2025-09-13 16:16:24,685 - stpipe.Detector1Pipeline.persistence - INFO - Step persistence running with args (<RampModel(1, 5, 2048, 2048) from jw02079004003_04101_00002_nis_uncal.fits>,).
2025-09-13 16:16:26,069 - stpipe.Detector1Pipeline.persistence - INFO - Saved model in /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage1/jw02079004003_04101_00002_nis_trapsfilled.fits
2025-09-13 16:16:26,072 - stpipe.Detector1Pipeline.persistence - INFO - Step persistence done
2025-09-13 16:16:26,257 - stpipe.Detector1Pipeline.dark_current - INFO - Step dark_current running with args (<RampModel(1, 5, 2048, 2048) from jw02079004003_04101_00002_nis_uncal.fits>,).
2025-09-13 16:16:26,267 - stpipe.Detector1Pipeline.dark_current - INFO - Using DARK reference file /home/runner/crds/references/jwst/niriss/jwst_niriss_dark_0228.fits
2025-09-13 16:16:26,480 - stcal.dark_current.dark_sub - INFO - Science data nints=1, ngroups=5, nframes=4, groupgap=0
2025-09-13 16:16:26,481 - stcal.dark_current.dark_sub - INFO - Dark data nints=1, ngroups=30, nframes=4, groupgap=0
2025-09-13 16:16:26,632 - stpipe.Detector1Pipeline.dark_current - INFO - Step dark_current done
2025-09-13 16:16:26,820 - stpipe.Detector1Pipeline.charge_migration - INFO - Step charge_migration running with args (<RampModel(1, 5, 2048, 2048) from jw02079004003_04101_00002_nis_uncal.fits>,).
2025-09-13 16:16:26,856 - jwst.charge_migration.charge_migration - INFO - Using signal_threshold: 22314.00
2025-09-13 16:16:26,943 - stpipe.Detector1Pipeline.charge_migration - INFO - Step charge_migration done
2025-09-13 16:16:27,128 - stpipe.Detector1Pipeline.jump - INFO - Step jump running with args (<RampModel(1, 5, 2048, 2048) from jw02079004003_04101_00002_nis_uncal.fits>,).
2025-09-13 16:16:27,136 - stpipe.Detector1Pipeline.jump - INFO - CR rejection threshold = 4 sigma
2025-09-13 16:16:27,136 - stpipe.Detector1Pipeline.jump - INFO - Maximum cores to use = 1
2025-09-13 16:16:27,157 - stpipe.Detector1Pipeline.jump - INFO - Using GAIN reference file: /home/runner/crds/references/jwst/niriss/jwst_niriss_gain_0006.fits
2025-09-13 16:16:27,159 - stpipe.Detector1Pipeline.jump - INFO - Using READNOISE reference file: /home/runner/crds/references/jwst/niriss/jwst_niriss_readnoise_0005.fits
2025-09-13 16:16:27,278 - stcal.jump.jump - INFO - Executing two-point difference method
2025-09-13 16:16:30,509 - stcal.jump.jump - INFO - Flagging Snowballs
2025-09-13 16:16:30,666 - stcal.jump.jump - INFO - Total snowballs = 24
2025-09-13 16:16:30,667 - stcal.jump.jump - INFO - Total elapsed time = 3.38813 sec
2025-09-13 16:16:30,694 - stpipe.Detector1Pipeline.jump - INFO - The execution time in seconds: 3.558178
2025-09-13 16:16:30,697 - stpipe.Detector1Pipeline.jump - INFO - Step jump done
2025-09-13 16:16:30,875 - stpipe.Detector1Pipeline.clean_flicker_noise - INFO - Step clean_flicker_noise running with args (<RampModel(1, 5, 2048, 2048) from jw02079004003_04101_00002_nis_uncal.fits>,).
2025-09-13 16:16:30,875 - stpipe.Detector1Pipeline.clean_flicker_noise - INFO - Step skipped.
2025-09-13 16:16:31,049 - stpipe.Detector1Pipeline.ramp_fit - INFO - Step ramp_fit running with args (<RampModel(1, 5, 2048, 2048) from jw02079004003_04101_00002_nis_uncal.fits>,).
2025-09-13 16:16:31,077 - jwst.ramp_fitting.ramp_fit_step - INFO - Using READNOISE reference file: /home/runner/crds/references/jwst/niriss/jwst_niriss_readnoise_0005.fits
2025-09-13 16:16:31,078 - jwst.ramp_fitting.ramp_fit_step - INFO - Using GAIN reference file: /home/runner/crds/references/jwst/niriss/jwst_niriss_gain_0006.fits
2025-09-13 16:16:31,103 - jwst.ramp_fitting.ramp_fit_step - INFO - Using algorithm = OLS_C
2025-09-13 16:16:31,104 - jwst.ramp_fitting.ramp_fit_step - INFO - Using weighting = optimal
2025-09-13 16:16:31,203 - stcal.ramp_fitting.ols_fit - INFO - Number of multiprocessing slices: 1
2025-09-13 16:16:33,006 - stcal.ramp_fitting.ols_fit - INFO - Ramp Fitting C Time: 1.7986459732055664
2025-09-13 16:16:33,048 - stpipe.Detector1Pipeline.ramp_fit - INFO - Step ramp_fit done
2025-09-13 16:16:33,216 - stpipe.Detector1Pipeline.gain_scale - INFO - Step gain_scale running with args (<ImageModel(2048, 2048) from jw02079004003_04101_00002_nis_uncal.fits>,).
2025-09-13 16:16:33,236 - stpipe.Detector1Pipeline.gain_scale - INFO - GAINFACT not found in gain reference file
2025-09-13 16:16:33,237 - stpipe.Detector1Pipeline.gain_scale - INFO - Step will be skipped
2025-09-13 16:16:33,239 - stpipe.Detector1Pipeline.gain_scale - INFO - Step gain_scale done
2025-09-13 16:16:33,417 - stpipe.Detector1Pipeline.gain_scale - INFO - Step gain_scale running with args (<CubeModel(1, 2048, 2048) from jw02079004003_04101_00002_nis_uncal.fits>,).
2025-09-13 16:16:33,437 - stpipe.Detector1Pipeline.gain_scale - INFO - GAINFACT not found in gain reference file
2025-09-13 16:16:33,437 - stpipe.Detector1Pipeline.gain_scale - INFO - Step will be skipped
2025-09-13 16:16:33,439 - stpipe.Detector1Pipeline.gain_scale - INFO - Step gain_scale done
2025-09-13 16:16:33,555 - stpipe.Detector1Pipeline - INFO - Saved model in /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage1/jw02079004003_04101_00002_nis_rateints.fits
2025-09-13 16:16:33,555 - jwst.pipeline.calwebb_detector1 - INFO - ... ending calwebb_detector1
2025-09-13 16:16:33,557 - jwst.stpipe.core - INFO - Results used CRDS context: jwst_1413.pmap
2025-09-13 16:16:33,671 - stpipe.Detector1Pipeline - INFO - Saved model in /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage1/jw02079004003_04101_00002_nis_rate.fits
2025-09-13 16:16:33,672 - stpipe.Detector1Pipeline - INFO - Step Detector1Pipeline done
2025-09-13 16:16:33,672 - jwst.stpipe.core - INFO - Results used jwst version: 1.19.1
2025-09-13 16:16:33,703 - CRDS - ERROR - Error determining best reference for 'pars-darkcurrentstep' = No match found.
2025-09-13 16:16:33,706 - stpipe - INFO - PARS-CHARGEMIGRATIONSTEP parameters found: /home/runner/crds/references/jwst/niriss/jwst_niriss_pars-chargemigrationstep_0016.asdf
2025-09-13 16:16:33,715 - stpipe - INFO - PARS-JUMPSTEP parameters found: /home/runner/crds/references/jwst/niriss/jwst_niriss_pars-jumpstep_0085.asdf
2025-09-13 16:16:33,726 - stpipe - INFO - PARS-DETECTOR1PIPELINE parameters found: /home/runner/crds/references/jwst/niriss/jwst_niriss_pars-detector1pipeline_0001.asdf
2025-09-13 16:16:33,742 - stpipe.Detector1Pipeline - INFO - Detector1Pipeline instance created.
2025-09-13 16:16:33,743 - stpipe.Detector1Pipeline.group_scale - INFO - GroupScaleStep instance created.
2025-09-13 16:16:33,743 - stpipe.Detector1Pipeline.dq_init - INFO - DQInitStep instance created.
2025-09-13 16:16:33,744 - stpipe.Detector1Pipeline.emicorr - INFO - EmiCorrStep instance created.
2025-09-13 16:16:33,745 - stpipe.Detector1Pipeline.saturation - INFO - SaturationStep instance created.
2025-09-13 16:16:33,746 - stpipe.Detector1Pipeline.ipc - INFO - IPCStep instance created.
2025-09-13 16:16:33,747 - stpipe.Detector1Pipeline.superbias - INFO - SuperBiasStep instance created.
2025-09-13 16:16:33,748 - stpipe.Detector1Pipeline.refpix - INFO - RefPixStep instance created.
2025-09-13 16:16:33,748 - stpipe.Detector1Pipeline.rscd - INFO - RscdStep instance created.
2025-09-13 16:16:33,749 - stpipe.Detector1Pipeline.firstframe - INFO - FirstFrameStep instance created.
2025-09-13 16:16:33,750 - stpipe.Detector1Pipeline.lastframe - INFO - LastFrameStep instance created.
2025-09-13 16:16:33,751 - stpipe.Detector1Pipeline.linearity - INFO - LinearityStep instance created.
2025-09-13 16:16:33,752 - stpipe.Detector1Pipeline.dark_current - INFO - DarkCurrentStep instance created.
2025-09-13 16:16:33,752 - stpipe.Detector1Pipeline.reset - INFO - ResetStep instance created.
2025-09-13 16:16:33,753 - stpipe.Detector1Pipeline.persistence - INFO - PersistenceStep instance created.
2025-09-13 16:16:33,754 - stpipe.Detector1Pipeline.charge_migration - INFO - ChargeMigrationStep instance created.
2025-09-13 16:16:33,756 - stpipe.Detector1Pipeline.jump - INFO - JumpStep instance created.
2025-09-13 16:16:33,757 - stpipe.Detector1Pipeline.clean_flicker_noise - INFO - CleanFlickerNoiseStep instance created.
2025-09-13 16:16:33,758 - stpipe.Detector1Pipeline.ramp_fit - INFO - RampFitStep instance created.
2025-09-13 16:16:33,759 - stpipe.Detector1Pipeline.gain_scale - INFO - GainScaleStep instance created.
2025-09-13 16:16:33,948 - stpipe.Detector1Pipeline - INFO - Step Detector1Pipeline running with args ('/home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/uncal/jw02079004003_04101_00003_nis_uncal.fits',).
2025-09-13 16:16:33,968 - stpipe.Detector1Pipeline - INFO - Step Detector1Pipeline parameters are:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage1
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: True
skip: False
suffix: None
search_output_file: True
input_dir: ''
save_calibrated_ramp: False
steps:
group_scale:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
dq_init:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
emicorr:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: True
suffix: None
search_output_file: True
input_dir: ''
algorithm: joint
nints_to_phase: None
nbins: None
scale_reference: True
onthefly_corr_freq: None
use_n_cycles: 3
fit_ints_separately: False
user_supplied_reffile: None
save_intermediate_results: False
saturation:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
n_pix_grow_sat: 1
use_readpatt: True
ipc:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: True
suffix: None
search_output_file: True
input_dir: ''
superbias:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
refpix:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
odd_even_columns: True
use_side_ref_pixels: True
side_smoothing_length: 11
side_gain: 1.0
odd_even_rows: True
ovr_corr_mitigation_ftr: 3.0
preserve_irs2_refpix: False
irs2_mean_subtraction: False
refpix_algorithm: median
sigreject: 4.0
gaussmooth: 1.0
halfwidth: 30
rscd:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
firstframe:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
bright_use_group1: False
lastframe:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
linearity:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
dark_current:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
dark_output: None
average_dark_current: None
reset:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
persistence:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
input_trapsfilled: ''
flag_pers_cutoff: 40.0
save_persistence: False
save_trapsfilled: True
modify_input: False
charge_migration:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
signal_threshold: 22314.0
jump:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
rejection_threshold: 4.0
three_group_rejection_threshold: 6.0
four_group_rejection_threshold: 5.0
maximum_cores: '1'
flag_4_neighbors: False
max_jump_to_flag_neighbors: 200.0
min_jump_to_flag_neighbors: 10.0
after_jump_flag_dn1: 1000
after_jump_flag_time1: 90
after_jump_flag_dn2: 0
after_jump_flag_time2: 0
expand_large_events: True
min_sat_area: 5
min_jump_area: 15.0
expand_factor: 1.75
use_ellipses: False
sat_required_snowball: True
min_sat_radius_extend: 5.0
sat_expand: 0
edge_size: 20
mask_snowball_core_next_int: True
snowball_time_masked_next_int: 4000
find_showers: False
max_shower_amplitude: 4.0
extend_snr_threshold: 1.2
extend_min_area: 90
extend_inner_radius: 1.0
extend_outer_radius: 2.6
extend_ellipse_expand_ratio: 1.1
time_masked_after_shower: 15.0
min_diffs_single_pass: 10
max_extended_radius: 100
minimum_groups: 3
minimum_sigclip_groups: 100
only_use_ints: True
clean_flicker_noise:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: True
suffix: None
search_output_file: True
input_dir: ''
fit_method: median
fit_by_channel: False
background_method: median
background_box_size: None
mask_science_regions: False
apply_flat_field: False
n_sigma: 2.0
fit_histogram: False
single_mask: True
user_mask: None
save_mask: False
save_background: False
save_noise: False
ramp_fit:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
algorithm: OLS_C
int_name: ''
save_opt: False
opt_name: ''
suppress_one_group: True
firstgroup: None
lastgroup: None
maximum_cores: '1'
gain_scale:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
2025-09-13 16:16:33,988 - stpipe.Detector1Pipeline - INFO - Prefetching reference files for dataset: 'jw02079004003_04101_00003_nis_uncal.fits' reftypes = ['dark', 'gain', 'linearity', 'mask', 'persat', 'readnoise', 'refpix', 'reset', 'rscd', 'saturation', 'sirskernel', 'superbias', 'trapdensity', 'trappars']
2025-09-13 16:16:33,991 - stpipe.Detector1Pipeline - INFO - Prefetch for DARK reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_dark_0228.fits'.
2025-09-13 16:16:33,992 - stpipe.Detector1Pipeline - INFO - Prefetch for GAIN reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_gain_0006.fits'.
2025-09-13 16:16:33,992 - stpipe.Detector1Pipeline - INFO - Prefetch for LINEARITY reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_linearity_0017.fits'.
2025-09-13 16:16:33,992 - stpipe.Detector1Pipeline - INFO - Prefetch for MASK reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_mask_0035.fits'.
2025-09-13 16:16:33,993 - stpipe.Detector1Pipeline - INFO - Prefetch for PERSAT reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_persat_0004.fits'.
2025-09-13 16:16:33,993 - stpipe.Detector1Pipeline - INFO - Prefetch for READNOISE reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_readnoise_0005.fits'.
2025-09-13 16:16:33,994 - stpipe.Detector1Pipeline - INFO - Prefetch for REFPIX reference file is 'N/A'.
2025-09-13 16:16:33,994 - stpipe.Detector1Pipeline - INFO - Prefetch for RESET reference file is 'N/A'.
2025-09-13 16:16:33,994 - stpipe.Detector1Pipeline - INFO - Prefetch for RSCD reference file is 'N/A'.
2025-09-13 16:16:33,995 - stpipe.Detector1Pipeline - INFO - Prefetch for SATURATION reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_saturation_0015.fits'.
2025-09-13 16:16:33,995 - stpipe.Detector1Pipeline - INFO - Prefetch for SIRSKERNEL reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_sirskernel_0001.asdf'.
2025-09-13 16:16:33,996 - stpipe.Detector1Pipeline - INFO - Prefetch for SUPERBIAS reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_superbias_0238.fits'.
2025-09-13 16:16:33,996 - stpipe.Detector1Pipeline - INFO - Prefetch for TRAPDENSITY reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_trapdensity_0002.fits'.
2025-09-13 16:16:33,997 - stpipe.Detector1Pipeline - INFO - Prefetch for TRAPPARS reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_trappars_0002.fits'.
2025-09-13 16:16:33,997 - jwst.pipeline.calwebb_detector1 - INFO - Starting calwebb_detector1 ...
2025-09-13 16:16:34,294 - stpipe.Detector1Pipeline.group_scale - INFO - Step group_scale running with args (<RampModel(1, 5, 2048, 2048) from jw02079004003_04101_00003_nis_uncal.fits>,).
2025-09-13 16:16:34,301 - stpipe.Detector1Pipeline.group_scale - INFO - NFRAMES and FRMDIVSR are equal; correction not needed
2025-09-13 16:16:34,302 - stpipe.Detector1Pipeline.group_scale - INFO - Step will be skipped
2025-09-13 16:16:34,303 - stpipe.Detector1Pipeline.group_scale - INFO - Step group_scale done
2025-09-13 16:16:34,490 - stpipe.Detector1Pipeline.dq_init - INFO - Step dq_init running with args (<RampModel(1, 5, 2048, 2048) from jw02079004003_04101_00003_nis_uncal.fits>,).
2025-09-13 16:16:34,500 - stpipe.Detector1Pipeline.dq_init - INFO - Using MASK reference file /home/runner/crds/references/jwst/niriss/jwst_niriss_mask_0035.fits
2025-09-13 16:16:34,625 - stpipe.Detector1Pipeline.dq_init - INFO - Step dq_init done
2025-09-13 16:16:34,802 - stpipe.Detector1Pipeline.saturation - INFO - Step saturation running with args (<RampModel(1, 5, 2048, 2048) from jw02079004003_04101_00003_nis_uncal.fits>,).
2025-09-13 16:16:34,812 - stpipe.Detector1Pipeline.saturation - INFO - Using SATURATION reference file /home/runner/crds/references/jwst/niriss/jwst_niriss_saturation_0015.fits
2025-09-13 16:16:34,813 - stpipe.Detector1Pipeline.saturation - INFO - Using SUPERBIAS reference file /home/runner/crds/references/jwst/niriss/jwst_niriss_superbias_0238.fits
2025-09-13 16:16:34,839 - stdatamodels.dynamicdq - WARNING - Keyword LOWILLUM does not correspond to an existing DQ mnemonic, so will be ignored
2025-09-13 16:16:34,840 - stdatamodels.dynamicdq - WARNING - Keyword LOWRESP does not correspond to an existing DQ mnemonic, so will be ignored
2025-09-13 16:16:34,845 - stdatamodels.dynamicdq - WARNING - Keyword UNCERTAIN does not correspond to an existing DQ mnemonic, so will be ignored
2025-09-13 16:16:34,905 - jwst.saturation.saturation - INFO - Using read_pattern with nframes 4
2025-09-13 16:16:35,234 - stcal.saturation.saturation - INFO - Detected 808 saturated pixels
2025-09-13 16:16:35,242 - stcal.saturation.saturation - INFO - Detected 1 A/D floor pixels
2025-09-13 16:16:35,249 - stpipe.Detector1Pipeline.saturation - INFO - Step saturation done
2025-09-13 16:16:35,428 - stpipe.Detector1Pipeline.ipc - INFO - Step ipc running with args (<RampModel(1, 5, 2048, 2048) from jw02079004003_04101_00003_nis_uncal.fits>,).
2025-09-13 16:16:35,429 - stpipe.Detector1Pipeline.ipc - INFO - Step skipped.
2025-09-13 16:16:35,607 - stpipe.Detector1Pipeline.superbias - INFO - Step superbias running with args (<RampModel(1, 5, 2048, 2048) from jw02079004003_04101_00003_nis_uncal.fits>,).
2025-09-13 16:16:35,616 - stpipe.Detector1Pipeline.superbias - INFO - Using SUPERBIAS reference file /home/runner/crds/references/jwst/niriss/jwst_niriss_superbias_0238.fits
2025-09-13 16:16:35,739 - stpipe.Detector1Pipeline.superbias - INFO - Step superbias done
2025-09-13 16:16:35,918 - stpipe.Detector1Pipeline.refpix - INFO - Step refpix running with args (<RampModel(1, 5, 2048, 2048) from jw02079004003_04101_00003_nis_uncal.fits>,).
2025-09-13 16:16:35,955 - jwst.refpix.reference_pixels - INFO - NIR full frame data
2025-09-13 16:16:35,956 - jwst.refpix.reference_pixels - INFO - The following parameters are valid for this mode:
2025-09-13 16:16:35,956 - jwst.refpix.reference_pixels - INFO - use_side_ref_pixels = True
2025-09-13 16:16:35,957 - jwst.refpix.reference_pixels - INFO - odd_even_columns = True
2025-09-13 16:16:35,957 - jwst.refpix.reference_pixels - INFO - side_smoothing_length = 11
2025-09-13 16:16:35,958 - jwst.refpix.reference_pixels - INFO - side_gain = 1.0
2025-09-13 16:16:35,958 - jwst.refpix.reference_pixels - INFO - The following parameter is not applicable and is ignored:
2025-09-13 16:16:35,959 - jwst.refpix.reference_pixels - INFO - odd_even_rows = False
2025-09-13 16:16:37,241 - stpipe.Detector1Pipeline.refpix - INFO - Step refpix done
2025-09-13 16:16:37,416 - stpipe.Detector1Pipeline.linearity - INFO - Step linearity running with args (<RampModel(1, 5, 2048, 2048) from jw02079004003_04101_00003_nis_uncal.fits>,).
2025-09-13 16:16:37,425 - stpipe.Detector1Pipeline.linearity - INFO - Using Linearity reference file /home/runner/crds/references/jwst/niriss/jwst_niriss_linearity_0017.fits
2025-09-13 16:16:37,466 - stdatamodels.dynamicdq - WARNING - Keyword LOWILLUM does not correspond to an existing DQ mnemonic, so will be ignored
2025-09-13 16:16:37,466 - stdatamodels.dynamicdq - WARNING - Keyword LOWRESP does not correspond to an existing DQ mnemonic, so will be ignored
2025-09-13 16:16:37,471 - stdatamodels.dynamicdq - WARNING - Keyword UNCERTAIN does not correspond to an existing DQ mnemonic, so will be ignored
2025-09-13 16:16:37,785 - stpipe.Detector1Pipeline.linearity - INFO - Step linearity done
2025-09-13 16:16:37,967 - stpipe.Detector1Pipeline.persistence - INFO - Step persistence running with args (<RampModel(1, 5, 2048, 2048) from jw02079004003_04101_00003_nis_uncal.fits>,).
2025-09-13 16:16:39,297 - stpipe.Detector1Pipeline.persistence - INFO - Saved model in /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage1/jw02079004003_04101_00003_nis_trapsfilled.fits
2025-09-13 16:16:39,300 - stpipe.Detector1Pipeline.persistence - INFO - Step persistence done
2025-09-13 16:16:39,483 - stpipe.Detector1Pipeline.dark_current - INFO - Step dark_current running with args (<RampModel(1, 5, 2048, 2048) from jw02079004003_04101_00003_nis_uncal.fits>,).
2025-09-13 16:16:39,493 - stpipe.Detector1Pipeline.dark_current - INFO - Using DARK reference file /home/runner/crds/references/jwst/niriss/jwst_niriss_dark_0228.fits
2025-09-13 16:16:39,704 - stcal.dark_current.dark_sub - INFO - Science data nints=1, ngroups=5, nframes=4, groupgap=0
2025-09-13 16:16:39,705 - stcal.dark_current.dark_sub - INFO - Dark data nints=1, ngroups=30, nframes=4, groupgap=0
2025-09-13 16:16:39,847 - stpipe.Detector1Pipeline.dark_current - INFO - Step dark_current done
2025-09-13 16:16:40,031 - stpipe.Detector1Pipeline.charge_migration - INFO - Step charge_migration running with args (<RampModel(1, 5, 2048, 2048) from jw02079004003_04101_00003_nis_uncal.fits>,).
2025-09-13 16:16:40,055 - jwst.charge_migration.charge_migration - INFO - Using signal_threshold: 22314.00
2025-09-13 16:16:40,136 - stpipe.Detector1Pipeline.charge_migration - INFO - Step charge_migration done
2025-09-13 16:16:40,312 - stpipe.Detector1Pipeline.jump - INFO - Step jump running with args (<RampModel(1, 5, 2048, 2048) from jw02079004003_04101_00003_nis_uncal.fits>,).
2025-09-13 16:16:40,320 - stpipe.Detector1Pipeline.jump - INFO - CR rejection threshold = 4 sigma
2025-09-13 16:16:40,321 - stpipe.Detector1Pipeline.jump - INFO - Maximum cores to use = 1
2025-09-13 16:16:40,340 - stpipe.Detector1Pipeline.jump - INFO - Using GAIN reference file: /home/runner/crds/references/jwst/niriss/jwst_niriss_gain_0006.fits
2025-09-13 16:16:40,343 - stpipe.Detector1Pipeline.jump - INFO - Using READNOISE reference file: /home/runner/crds/references/jwst/niriss/jwst_niriss_readnoise_0005.fits
2025-09-13 16:16:40,452 - stcal.jump.jump - INFO - Executing two-point difference method
2025-09-13 16:16:43,700 - stcal.jump.jump - INFO - Flagging Snowballs
2025-09-13 16:16:43,851 - stcal.jump.jump - INFO - Total snowballs = 18
2025-09-13 16:16:43,852 - stcal.jump.jump - INFO - Total elapsed time = 3.39908 sec
2025-09-13 16:16:43,879 - stpipe.Detector1Pipeline.jump - INFO - The execution time in seconds: 3.558644
2025-09-13 16:16:43,882 - stpipe.Detector1Pipeline.jump - INFO - Step jump done
2025-09-13 16:16:44,055 - stpipe.Detector1Pipeline.clean_flicker_noise - INFO - Step clean_flicker_noise running with args (<RampModel(1, 5, 2048, 2048) from jw02079004003_04101_00003_nis_uncal.fits>,).
2025-09-13 16:16:44,056 - stpipe.Detector1Pipeline.clean_flicker_noise - INFO - Step skipped.
2025-09-13 16:16:44,230 - stpipe.Detector1Pipeline.ramp_fit - INFO - Step ramp_fit running with args (<RampModel(1, 5, 2048, 2048) from jw02079004003_04101_00003_nis_uncal.fits>,).
2025-09-13 16:16:44,259 - jwst.ramp_fitting.ramp_fit_step - INFO - Using READNOISE reference file: /home/runner/crds/references/jwst/niriss/jwst_niriss_readnoise_0005.fits
2025-09-13 16:16:44,260 - jwst.ramp_fitting.ramp_fit_step - INFO - Using GAIN reference file: /home/runner/crds/references/jwst/niriss/jwst_niriss_gain_0006.fits
2025-09-13 16:16:44,286 - jwst.ramp_fitting.ramp_fit_step - INFO - Using algorithm = OLS_C
2025-09-13 16:16:44,287 - jwst.ramp_fitting.ramp_fit_step - INFO - Using weighting = optimal
2025-09-13 16:16:44,389 - stcal.ramp_fitting.ols_fit - INFO - Number of multiprocessing slices: 1
2025-09-13 16:16:46,209 - stcal.ramp_fitting.ols_fit - INFO - Ramp Fitting C Time: 1.8156206607818604
2025-09-13 16:16:46,250 - stpipe.Detector1Pipeline.ramp_fit - INFO - Step ramp_fit done
2025-09-13 16:16:46,425 - stpipe.Detector1Pipeline.gain_scale - INFO - Step gain_scale running with args (<ImageModel(2048, 2048) from jw02079004003_04101_00003_nis_uncal.fits>,).
2025-09-13 16:16:46,445 - stpipe.Detector1Pipeline.gain_scale - INFO - GAINFACT not found in gain reference file
2025-09-13 16:16:46,446 - stpipe.Detector1Pipeline.gain_scale - INFO - Step will be skipped
2025-09-13 16:16:46,448 - stpipe.Detector1Pipeline.gain_scale - INFO - Step gain_scale done
2025-09-13 16:16:46,623 - stpipe.Detector1Pipeline.gain_scale - INFO - Step gain_scale running with args (<CubeModel(1, 2048, 2048) from jw02079004003_04101_00003_nis_uncal.fits>,).
2025-09-13 16:16:46,643 - stpipe.Detector1Pipeline.gain_scale - INFO - GAINFACT not found in gain reference file
2025-09-13 16:16:46,644 - stpipe.Detector1Pipeline.gain_scale - INFO - Step will be skipped
2025-09-13 16:16:46,645 - stpipe.Detector1Pipeline.gain_scale - INFO - Step gain_scale done
2025-09-13 16:16:46,759 - stpipe.Detector1Pipeline - INFO - Saved model in /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage1/jw02079004003_04101_00003_nis_rateints.fits
2025-09-13 16:16:46,760 - jwst.pipeline.calwebb_detector1 - INFO - ... ending calwebb_detector1
2025-09-13 16:16:46,761 - jwst.stpipe.core - INFO - Results used CRDS context: jwst_1413.pmap
2025-09-13 16:16:46,874 - stpipe.Detector1Pipeline - INFO - Saved model in /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage1/jw02079004003_04101_00003_nis_rate.fits
2025-09-13 16:16:46,874 - stpipe.Detector1Pipeline - INFO - Step Detector1Pipeline done
2025-09-13 16:16:46,875 - jwst.stpipe.core - INFO - Results used jwst version: 1.19.1
2025-09-13 16:16:46,905 - CRDS - ERROR - Error determining best reference for 'pars-darkcurrentstep' = No match found.
2025-09-13 16:16:46,908 - stpipe - INFO - PARS-CHARGEMIGRATIONSTEP parameters found: /home/runner/crds/references/jwst/niriss/jwst_niriss_pars-chargemigrationstep_0016.asdf
2025-09-13 16:16:46,916 - stpipe - INFO - PARS-JUMPSTEP parameters found: /home/runner/crds/references/jwst/niriss/jwst_niriss_pars-jumpstep_0085.asdf
2025-09-13 16:16:46,927 - stpipe - INFO - PARS-DETECTOR1PIPELINE parameters found: /home/runner/crds/references/jwst/niriss/jwst_niriss_pars-detector1pipeline_0001.asdf
2025-09-13 16:16:46,942 - stpipe.Detector1Pipeline - INFO - Detector1Pipeline instance created.
2025-09-13 16:16:46,943 - stpipe.Detector1Pipeline.group_scale - INFO - GroupScaleStep instance created.
2025-09-13 16:16:46,944 - stpipe.Detector1Pipeline.dq_init - INFO - DQInitStep instance created.
2025-09-13 16:16:46,945 - stpipe.Detector1Pipeline.emicorr - INFO - EmiCorrStep instance created.
2025-09-13 16:16:46,946 - stpipe.Detector1Pipeline.saturation - INFO - SaturationStep instance created.
2025-09-13 16:16:46,946 - stpipe.Detector1Pipeline.ipc - INFO - IPCStep instance created.
2025-09-13 16:16:46,947 - stpipe.Detector1Pipeline.superbias - INFO - SuperBiasStep instance created.
2025-09-13 16:16:46,948 - stpipe.Detector1Pipeline.refpix - INFO - RefPixStep instance created.
2025-09-13 16:16:46,949 - stpipe.Detector1Pipeline.rscd - INFO - RscdStep instance created.
2025-09-13 16:16:46,949 - stpipe.Detector1Pipeline.firstframe - INFO - FirstFrameStep instance created.
2025-09-13 16:16:46,950 - stpipe.Detector1Pipeline.lastframe - INFO - LastFrameStep instance created.
2025-09-13 16:16:46,951 - stpipe.Detector1Pipeline.linearity - INFO - LinearityStep instance created.
2025-09-13 16:16:46,952 - stpipe.Detector1Pipeline.dark_current - INFO - DarkCurrentStep instance created.
2025-09-13 16:16:46,952 - stpipe.Detector1Pipeline.reset - INFO - ResetStep instance created.
2025-09-13 16:16:46,953 - stpipe.Detector1Pipeline.persistence - INFO - PersistenceStep instance created.
2025-09-13 16:16:46,954 - stpipe.Detector1Pipeline.charge_migration - INFO - ChargeMigrationStep instance created.
2025-09-13 16:16:46,956 - stpipe.Detector1Pipeline.jump - INFO - JumpStep instance created.
2025-09-13 16:16:46,957 - stpipe.Detector1Pipeline.clean_flicker_noise - INFO - CleanFlickerNoiseStep instance created.
2025-09-13 16:16:46,958 - stpipe.Detector1Pipeline.ramp_fit - INFO - RampFitStep instance created.
2025-09-13 16:16:46,958 - stpipe.Detector1Pipeline.gain_scale - INFO - GainScaleStep instance created.
2025-09-13 16:16:47,142 - stpipe.Detector1Pipeline - INFO - Step Detector1Pipeline running with args ('/home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/uncal/jw02079004003_04101_00004_nis_uncal.fits',).
2025-09-13 16:16:47,162 - stpipe.Detector1Pipeline - INFO - Step Detector1Pipeline parameters are:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage1
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: True
skip: False
suffix: None
search_output_file: True
input_dir: ''
save_calibrated_ramp: False
steps:
group_scale:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
dq_init:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
emicorr:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: True
suffix: None
search_output_file: True
input_dir: ''
algorithm: joint
nints_to_phase: None
nbins: None
scale_reference: True
onthefly_corr_freq: None
use_n_cycles: 3
fit_ints_separately: False
user_supplied_reffile: None
save_intermediate_results: False
saturation:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
n_pix_grow_sat: 1
use_readpatt: True
ipc:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: True
suffix: None
search_output_file: True
input_dir: ''
superbias:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
refpix:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
odd_even_columns: True
use_side_ref_pixels: True
side_smoothing_length: 11
side_gain: 1.0
odd_even_rows: True
ovr_corr_mitigation_ftr: 3.0
preserve_irs2_refpix: False
irs2_mean_subtraction: False
refpix_algorithm: median
sigreject: 4.0
gaussmooth: 1.0
halfwidth: 30
rscd:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
firstframe:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
bright_use_group1: False
lastframe:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
linearity:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
dark_current:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
dark_output: None
average_dark_current: None
reset:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
persistence:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
input_trapsfilled: ''
flag_pers_cutoff: 40.0
save_persistence: False
save_trapsfilled: True
modify_input: False
charge_migration:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
signal_threshold: 22314.0
jump:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
rejection_threshold: 4.0
three_group_rejection_threshold: 6.0
four_group_rejection_threshold: 5.0
maximum_cores: '1'
flag_4_neighbors: False
max_jump_to_flag_neighbors: 200.0
min_jump_to_flag_neighbors: 10.0
after_jump_flag_dn1: 1000
after_jump_flag_time1: 90
after_jump_flag_dn2: 0
after_jump_flag_time2: 0
expand_large_events: True
min_sat_area: 5
min_jump_area: 15.0
expand_factor: 1.75
use_ellipses: False
sat_required_snowball: True
min_sat_radius_extend: 5.0
sat_expand: 0
edge_size: 20
mask_snowball_core_next_int: True
snowball_time_masked_next_int: 4000
find_showers: False
max_shower_amplitude: 4.0
extend_snr_threshold: 1.2
extend_min_area: 90
extend_inner_radius: 1.0
extend_outer_radius: 2.6
extend_ellipse_expand_ratio: 1.1
time_masked_after_shower: 15.0
min_diffs_single_pass: 10
max_extended_radius: 100
minimum_groups: 3
minimum_sigclip_groups: 100
only_use_ints: True
clean_flicker_noise:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: True
suffix: None
search_output_file: True
input_dir: ''
fit_method: median
fit_by_channel: False
background_method: median
background_box_size: None
mask_science_regions: False
apply_flat_field: False
n_sigma: 2.0
fit_histogram: False
single_mask: True
user_mask: None
save_mask: False
save_background: False
save_noise: False
ramp_fit:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
algorithm: OLS_C
int_name: ''
save_opt: False
opt_name: ''
suppress_one_group: True
firstgroup: None
lastgroup: None
maximum_cores: '1'
gain_scale:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
2025-09-13 16:16:47,183 - stpipe.Detector1Pipeline - INFO - Prefetching reference files for dataset: 'jw02079004003_04101_00004_nis_uncal.fits' reftypes = ['dark', 'gain', 'linearity', 'mask', 'persat', 'readnoise', 'refpix', 'reset', 'rscd', 'saturation', 'sirskernel', 'superbias', 'trapdensity', 'trappars']
2025-09-13 16:16:47,186 - stpipe.Detector1Pipeline - INFO - Prefetch for DARK reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_dark_0228.fits'.
2025-09-13 16:16:47,187 - stpipe.Detector1Pipeline - INFO - Prefetch for GAIN reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_gain_0006.fits'.
2025-09-13 16:16:47,187 - stpipe.Detector1Pipeline - INFO - Prefetch for LINEARITY reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_linearity_0017.fits'.
2025-09-13 16:16:47,188 - stpipe.Detector1Pipeline - INFO - Prefetch for MASK reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_mask_0035.fits'.
2025-09-13 16:16:47,188 - stpipe.Detector1Pipeline - INFO - Prefetch for PERSAT reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_persat_0004.fits'.
2025-09-13 16:16:47,189 - stpipe.Detector1Pipeline - INFO - Prefetch for READNOISE reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_readnoise_0005.fits'.
2025-09-13 16:16:47,189 - stpipe.Detector1Pipeline - INFO - Prefetch for REFPIX reference file is 'N/A'.
2025-09-13 16:16:47,189 - stpipe.Detector1Pipeline - INFO - Prefetch for RESET reference file is 'N/A'.
2025-09-13 16:16:47,190 - stpipe.Detector1Pipeline - INFO - Prefetch for RSCD reference file is 'N/A'.
2025-09-13 16:16:47,190 - stpipe.Detector1Pipeline - INFO - Prefetch for SATURATION reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_saturation_0015.fits'.
2025-09-13 16:16:47,191 - stpipe.Detector1Pipeline - INFO - Prefetch for SIRSKERNEL reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_sirskernel_0001.asdf'.
2025-09-13 16:16:47,191 - stpipe.Detector1Pipeline - INFO - Prefetch for SUPERBIAS reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_superbias_0238.fits'.
2025-09-13 16:16:47,191 - stpipe.Detector1Pipeline - INFO - Prefetch for TRAPDENSITY reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_trapdensity_0002.fits'.
2025-09-13 16:16:47,192 - stpipe.Detector1Pipeline - INFO - Prefetch for TRAPPARS reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_trappars_0002.fits'.
2025-09-13 16:16:47,192 - jwst.pipeline.calwebb_detector1 - INFO - Starting calwebb_detector1 ...
2025-09-13 16:16:47,491 - stpipe.Detector1Pipeline.group_scale - INFO - Step group_scale running with args (<RampModel(1, 5, 2048, 2048) from jw02079004003_04101_00004_nis_uncal.fits>,).
2025-09-13 16:16:47,499 - stpipe.Detector1Pipeline.group_scale - INFO - NFRAMES and FRMDIVSR are equal; correction not needed
2025-09-13 16:16:47,499 - stpipe.Detector1Pipeline.group_scale - INFO - Step will be skipped
2025-09-13 16:16:47,500 - stpipe.Detector1Pipeline.group_scale - INFO - Step group_scale done
2025-09-13 16:16:47,677 - stpipe.Detector1Pipeline.dq_init - INFO - Step dq_init running with args (<RampModel(1, 5, 2048, 2048) from jw02079004003_04101_00004_nis_uncal.fits>,).
2025-09-13 16:16:47,686 - stpipe.Detector1Pipeline.dq_init - INFO - Using MASK reference file /home/runner/crds/references/jwst/niriss/jwst_niriss_mask_0035.fits
2025-09-13 16:16:47,829 - stpipe.Detector1Pipeline.dq_init - INFO - Step dq_init done
2025-09-13 16:16:48,011 - stpipe.Detector1Pipeline.saturation - INFO - Step saturation running with args (<RampModel(1, 5, 2048, 2048) from jw02079004003_04101_00004_nis_uncal.fits>,).
2025-09-13 16:16:48,022 - stpipe.Detector1Pipeline.saturation - INFO - Using SATURATION reference file /home/runner/crds/references/jwst/niriss/jwst_niriss_saturation_0015.fits
2025-09-13 16:16:48,022 - stpipe.Detector1Pipeline.saturation - INFO - Using SUPERBIAS reference file /home/runner/crds/references/jwst/niriss/jwst_niriss_superbias_0238.fits
2025-09-13 16:16:48,049 - stdatamodels.dynamicdq - WARNING - Keyword LOWILLUM does not correspond to an existing DQ mnemonic, so will be ignored
2025-09-13 16:16:48,050 - stdatamodels.dynamicdq - WARNING - Keyword LOWRESP does not correspond to an existing DQ mnemonic, so will be ignored
2025-09-13 16:16:48,055 - stdatamodels.dynamicdq - WARNING - Keyword UNCERTAIN does not correspond to an existing DQ mnemonic, so will be ignored
2025-09-13 16:16:48,120 - jwst.saturation.saturation - INFO - Using read_pattern with nframes 4
2025-09-13 16:16:48,454 - stcal.saturation.saturation - INFO - Detected 831 saturated pixels
2025-09-13 16:16:48,464 - stcal.saturation.saturation - INFO - Detected 1 A/D floor pixels
2025-09-13 16:16:48,471 - stpipe.Detector1Pipeline.saturation - INFO - Step saturation done
2025-09-13 16:16:48,658 - stpipe.Detector1Pipeline.ipc - INFO - Step ipc running with args (<RampModel(1, 5, 2048, 2048) from jw02079004003_04101_00004_nis_uncal.fits>,).
2025-09-13 16:16:48,658 - stpipe.Detector1Pipeline.ipc - INFO - Step skipped.
2025-09-13 16:16:48,841 - stpipe.Detector1Pipeline.superbias - INFO - Step superbias running with args (<RampModel(1, 5, 2048, 2048) from jw02079004003_04101_00004_nis_uncal.fits>,).
2025-09-13 16:16:48,850 - stpipe.Detector1Pipeline.superbias - INFO - Using SUPERBIAS reference file /home/runner/crds/references/jwst/niriss/jwst_niriss_superbias_0238.fits
2025-09-13 16:16:48,991 - stpipe.Detector1Pipeline.superbias - INFO - Step superbias done
2025-09-13 16:16:49,180 - stpipe.Detector1Pipeline.refpix - INFO - Step refpix running with args (<RampModel(1, 5, 2048, 2048) from jw02079004003_04101_00004_nis_uncal.fits>,).
2025-09-13 16:16:49,218 - jwst.refpix.reference_pixels - INFO - NIR full frame data
2025-09-13 16:16:49,218 - jwst.refpix.reference_pixels - INFO - The following parameters are valid for this mode:
2025-09-13 16:16:49,219 - jwst.refpix.reference_pixels - INFO - use_side_ref_pixels = True
2025-09-13 16:16:49,219 - jwst.refpix.reference_pixels - INFO - odd_even_columns = True
2025-09-13 16:16:49,220 - jwst.refpix.reference_pixels - INFO - side_smoothing_length = 11
2025-09-13 16:16:49,220 - jwst.refpix.reference_pixels - INFO - side_gain = 1.0
2025-09-13 16:16:49,220 - jwst.refpix.reference_pixels - INFO - The following parameter is not applicable and is ignored:
2025-09-13 16:16:49,221 - jwst.refpix.reference_pixels - INFO - odd_even_rows = False
2025-09-13 16:16:50,492 - stpipe.Detector1Pipeline.refpix - INFO - Step refpix done
2025-09-13 16:16:50,660 - stpipe.Detector1Pipeline.linearity - INFO - Step linearity running with args (<RampModel(1, 5, 2048, 2048) from jw02079004003_04101_00004_nis_uncal.fits>,).
2025-09-13 16:16:50,669 - stpipe.Detector1Pipeline.linearity - INFO - Using Linearity reference file /home/runner/crds/references/jwst/niriss/jwst_niriss_linearity_0017.fits
2025-09-13 16:16:50,715 - stdatamodels.dynamicdq - WARNING - Keyword LOWILLUM does not correspond to an existing DQ mnemonic, so will be ignored
2025-09-13 16:16:50,716 - stdatamodels.dynamicdq - WARNING - Keyword LOWRESP does not correspond to an existing DQ mnemonic, so will be ignored
2025-09-13 16:16:50,720 - stdatamodels.dynamicdq - WARNING - Keyword UNCERTAIN does not correspond to an existing DQ mnemonic, so will be ignored
2025-09-13 16:16:51,030 - stpipe.Detector1Pipeline.linearity - INFO - Step linearity done
2025-09-13 16:16:51,209 - stpipe.Detector1Pipeline.persistence - INFO - Step persistence running with args (<RampModel(1, 5, 2048, 2048) from jw02079004003_04101_00004_nis_uncal.fits>,).
2025-09-13 16:16:52,526 - stpipe.Detector1Pipeline.persistence - INFO - Saved model in /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage1/jw02079004003_04101_00004_nis_trapsfilled.fits
2025-09-13 16:16:52,529 - stpipe.Detector1Pipeline.persistence - INFO - Step persistence done
2025-09-13 16:16:52,712 - stpipe.Detector1Pipeline.dark_current - INFO - Step dark_current running with args (<RampModel(1, 5, 2048, 2048) from jw02079004003_04101_00004_nis_uncal.fits>,).
2025-09-13 16:16:52,721 - stpipe.Detector1Pipeline.dark_current - INFO - Using DARK reference file /home/runner/crds/references/jwst/niriss/jwst_niriss_dark_0228.fits
2025-09-13 16:16:52,948 - stcal.dark_current.dark_sub - INFO - Science data nints=1, ngroups=5, nframes=4, groupgap=0
2025-09-13 16:16:52,949 - stcal.dark_current.dark_sub - INFO - Dark data nints=1, ngroups=30, nframes=4, groupgap=0
2025-09-13 16:16:53,091 - stpipe.Detector1Pipeline.dark_current - INFO - Step dark_current done
2025-09-13 16:16:53,271 - stpipe.Detector1Pipeline.charge_migration - INFO - Step charge_migration running with args (<RampModel(1, 5, 2048, 2048) from jw02079004003_04101_00004_nis_uncal.fits>,).
2025-09-13 16:16:53,296 - jwst.charge_migration.charge_migration - INFO - Using signal_threshold: 22314.00
2025-09-13 16:16:53,372 - stpipe.Detector1Pipeline.charge_migration - INFO - Step charge_migration done
2025-09-13 16:16:53,554 - stpipe.Detector1Pipeline.jump - INFO - Step jump running with args (<RampModel(1, 5, 2048, 2048) from jw02079004003_04101_00004_nis_uncal.fits>,).
2025-09-13 16:16:53,562 - stpipe.Detector1Pipeline.jump - INFO - CR rejection threshold = 4 sigma
2025-09-13 16:16:53,563 - stpipe.Detector1Pipeline.jump - INFO - Maximum cores to use = 1
2025-09-13 16:16:53,582 - stpipe.Detector1Pipeline.jump - INFO - Using GAIN reference file: /home/runner/crds/references/jwst/niriss/jwst_niriss_gain_0006.fits
2025-09-13 16:16:53,585 - stpipe.Detector1Pipeline.jump - INFO - Using READNOISE reference file: /home/runner/crds/references/jwst/niriss/jwst_niriss_readnoise_0005.fits
2025-09-13 16:16:53,699 - stcal.jump.jump - INFO - Executing two-point difference method
2025-09-13 16:16:56,845 - stcal.jump.jump - INFO - Flagging Snowballs
2025-09-13 16:16:56,985 - stcal.jump.jump - INFO - Total snowballs = 30
2025-09-13 16:16:56,986 - stcal.jump.jump - INFO - Total elapsed time = 3.28602 sec
2025-09-13 16:16:57,012 - stpipe.Detector1Pipeline.jump - INFO - The execution time in seconds: 3.449464
2025-09-13 16:16:57,015 - stpipe.Detector1Pipeline.jump - INFO - Step jump done
2025-09-13 16:16:57,194 - stpipe.Detector1Pipeline.clean_flicker_noise - INFO - Step clean_flicker_noise running with args (<RampModel(1, 5, 2048, 2048) from jw02079004003_04101_00004_nis_uncal.fits>,).
2025-09-13 16:16:57,195 - stpipe.Detector1Pipeline.clean_flicker_noise - INFO - Step skipped.
2025-09-13 16:16:57,359 - stpipe.Detector1Pipeline.ramp_fit - INFO - Step ramp_fit running with args (<RampModel(1, 5, 2048, 2048) from jw02079004003_04101_00004_nis_uncal.fits>,).
2025-09-13 16:16:57,388 - jwst.ramp_fitting.ramp_fit_step - INFO - Using READNOISE reference file: /home/runner/crds/references/jwst/niriss/jwst_niriss_readnoise_0005.fits
2025-09-13 16:16:57,388 - jwst.ramp_fitting.ramp_fit_step - INFO - Using GAIN reference file: /home/runner/crds/references/jwst/niriss/jwst_niriss_gain_0006.fits
2025-09-13 16:16:57,414 - jwst.ramp_fitting.ramp_fit_step - INFO - Using algorithm = OLS_C
2025-09-13 16:16:57,415 - jwst.ramp_fitting.ramp_fit_step - INFO - Using weighting = optimal
2025-09-13 16:16:57,520 - stcal.ramp_fitting.ols_fit - INFO - Number of multiprocessing slices: 1
2025-09-13 16:16:59,324 - stcal.ramp_fitting.ols_fit - INFO - Ramp Fitting C Time: 1.8004136085510254
2025-09-13 16:16:59,366 - stpipe.Detector1Pipeline.ramp_fit - INFO - Step ramp_fit done
2025-09-13 16:16:59,545 - stpipe.Detector1Pipeline.gain_scale - INFO - Step gain_scale running with args (<ImageModel(2048, 2048) from jw02079004003_04101_00004_nis_uncal.fits>,).
2025-09-13 16:16:59,565 - stpipe.Detector1Pipeline.gain_scale - INFO - GAINFACT not found in gain reference file
2025-09-13 16:16:59,566 - stpipe.Detector1Pipeline.gain_scale - INFO - Step will be skipped
2025-09-13 16:16:59,568 - stpipe.Detector1Pipeline.gain_scale - INFO - Step gain_scale done
2025-09-13 16:16:59,737 - stpipe.Detector1Pipeline.gain_scale - INFO - Step gain_scale running with args (<CubeModel(1, 2048, 2048) from jw02079004003_04101_00004_nis_uncal.fits>,).
2025-09-13 16:16:59,757 - stpipe.Detector1Pipeline.gain_scale - INFO - GAINFACT not found in gain reference file
2025-09-13 16:16:59,758 - stpipe.Detector1Pipeline.gain_scale - INFO - Step will be skipped
2025-09-13 16:16:59,760 - stpipe.Detector1Pipeline.gain_scale - INFO - Step gain_scale done
2025-09-13 16:16:59,870 - stpipe.Detector1Pipeline - INFO - Saved model in /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage1/jw02079004003_04101_00004_nis_rateints.fits
2025-09-13 16:16:59,870 - jwst.pipeline.calwebb_detector1 - INFO - ... ending calwebb_detector1
2025-09-13 16:16:59,872 - jwst.stpipe.core - INFO - Results used CRDS context: jwst_1413.pmap
2025-09-13 16:16:59,982 - stpipe.Detector1Pipeline - INFO - Saved model in /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage1/jw02079004003_04101_00004_nis_rate.fits
2025-09-13 16:16:59,983 - stpipe.Detector1Pipeline - INFO - Step Detector1Pipeline done
2025-09-13 16:16:59,983 - jwst.stpipe.core - INFO - Results used jwst version: 1.19.1
2025-09-13 16:17:00,012 - CRDS - ERROR - Error determining best reference for 'pars-darkcurrentstep' = No match found.
2025-09-13 16:17:00,015 - CRDS - INFO - Fetching /home/runner/crds/references/jwst/niriss/jwst_niriss_pars-chargemigrationstep_0001.asdf 1.1 K bytes (1 / 1 files) (0 / 1.1 K bytes)
2025-09-13 16:17:00,290 - stpipe - INFO - PARS-CHARGEMIGRATIONSTEP parameters found: /home/runner/crds/references/jwst/niriss/jwst_niriss_pars-chargemigrationstep_0001.asdf
2025-09-13 16:17:00,299 - CRDS - INFO - Fetching /home/runner/crds/references/jwst/niriss/jwst_niriss_pars-jumpstep_0091.asdf 1.6 K bytes (1 / 1 files) (0 / 1.6 K bytes)
2025-09-13 16:17:00,550 - stpipe - INFO - PARS-JUMPSTEP parameters found: /home/runner/crds/references/jwst/niriss/jwst_niriss_pars-jumpstep_0091.asdf
2025-09-13 16:17:00,562 - stpipe - INFO - PARS-DETECTOR1PIPELINE parameters found: /home/runner/crds/references/jwst/niriss/jwst_niriss_pars-detector1pipeline_0001.asdf
2025-09-13 16:17:00,577 - stpipe.Detector1Pipeline - INFO - Detector1Pipeline instance created.
2025-09-13 16:17:00,577 - stpipe.Detector1Pipeline.group_scale - INFO - GroupScaleStep instance created.
2025-09-13 16:17:00,578 - stpipe.Detector1Pipeline.dq_init - INFO - DQInitStep instance created.
2025-09-13 16:17:00,580 - stpipe.Detector1Pipeline.emicorr - INFO - EmiCorrStep instance created.
2025-09-13 16:17:00,580 - stpipe.Detector1Pipeline.saturation - INFO - SaturationStep instance created.
2025-09-13 16:17:00,581 - stpipe.Detector1Pipeline.ipc - INFO - IPCStep instance created.
2025-09-13 16:17:00,582 - stpipe.Detector1Pipeline.superbias - INFO - SuperBiasStep instance created.
2025-09-13 16:17:00,583 - stpipe.Detector1Pipeline.refpix - INFO - RefPixStep instance created.
2025-09-13 16:17:00,584 - stpipe.Detector1Pipeline.rscd - INFO - RscdStep instance created.
2025-09-13 16:17:00,585 - stpipe.Detector1Pipeline.firstframe - INFO - FirstFrameStep instance created.
2025-09-13 16:17:00,585 - stpipe.Detector1Pipeline.lastframe - INFO - LastFrameStep instance created.
2025-09-13 16:17:00,586 - stpipe.Detector1Pipeline.linearity - INFO - LinearityStep instance created.
2025-09-13 16:17:00,587 - stpipe.Detector1Pipeline.dark_current - INFO - DarkCurrentStep instance created.
2025-09-13 16:17:00,587 - stpipe.Detector1Pipeline.reset - INFO - ResetStep instance created.
2025-09-13 16:17:00,588 - stpipe.Detector1Pipeline.persistence - INFO - PersistenceStep instance created.
2025-09-13 16:17:00,589 - stpipe.Detector1Pipeline.charge_migration - INFO - ChargeMigrationStep instance created.
2025-09-13 16:17:00,590 - stpipe.Detector1Pipeline.jump - INFO - JumpStep instance created.
2025-09-13 16:17:00,591 - stpipe.Detector1Pipeline.clean_flicker_noise - INFO - CleanFlickerNoiseStep instance created.
2025-09-13 16:17:00,592 - stpipe.Detector1Pipeline.ramp_fit - INFO - RampFitStep instance created.
2025-09-13 16:17:00,593 - stpipe.Detector1Pipeline.gain_scale - INFO - GainScaleStep instance created.
2025-09-13 16:17:00,761 - stpipe.Detector1Pipeline - INFO - Step Detector1Pipeline running with args ('/home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/uncal/jw02079004003_05101_00001_nis_uncal.fits',).
2025-09-13 16:17:00,781 - stpipe.Detector1Pipeline - INFO - Step Detector1Pipeline parameters are:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage1
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: True
skip: False
suffix: None
search_output_file: True
input_dir: ''
save_calibrated_ramp: False
steps:
group_scale:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
dq_init:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
emicorr:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: True
suffix: None
search_output_file: True
input_dir: ''
algorithm: joint
nints_to_phase: None
nbins: None
scale_reference: True
onthefly_corr_freq: None
use_n_cycles: 3
fit_ints_separately: False
user_supplied_reffile: None
save_intermediate_results: False
saturation:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
n_pix_grow_sat: 1
use_readpatt: True
ipc:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: True
suffix: None
search_output_file: True
input_dir: ''
superbias:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
refpix:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
odd_even_columns: True
use_side_ref_pixels: True
side_smoothing_length: 11
side_gain: 1.0
odd_even_rows: True
ovr_corr_mitigation_ftr: 3.0
preserve_irs2_refpix: False
irs2_mean_subtraction: False
refpix_algorithm: median
sigreject: 4.0
gaussmooth: 1.0
halfwidth: 30
rscd:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
firstframe:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
bright_use_group1: False
lastframe:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
linearity:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
dark_current:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
dark_output: None
average_dark_current: None
reset:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
persistence:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
input_trapsfilled: ''
flag_pers_cutoff: 40.0
save_persistence: False
save_trapsfilled: True
modify_input: False
charge_migration:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
signal_threshold: 22314.0
jump:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
rejection_threshold: 6.0
three_group_rejection_threshold: 6.0
four_group_rejection_threshold: 5.0
maximum_cores: '1'
flag_4_neighbors: False
max_jump_to_flag_neighbors: 200.0
min_jump_to_flag_neighbors: 10.0
after_jump_flag_dn1: 1000
after_jump_flag_time1: 90
after_jump_flag_dn2: 0
after_jump_flag_time2: 0
expand_large_events: True
min_sat_area: 5
min_jump_area: 15.0
expand_factor: 1.75
use_ellipses: False
sat_required_snowball: True
min_sat_radius_extend: 5.0
sat_expand: 0
edge_size: 20
mask_snowball_core_next_int: True
snowball_time_masked_next_int: 4000
find_showers: False
max_shower_amplitude: 4.0
extend_snr_threshold: 1.2
extend_min_area: 90
extend_inner_radius: 1.0
extend_outer_radius: 2.6
extend_ellipse_expand_ratio: 1.1
time_masked_after_shower: 15.0
min_diffs_single_pass: 10
max_extended_radius: 100
minimum_groups: 3
minimum_sigclip_groups: 100
only_use_ints: True
clean_flicker_noise:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: True
suffix: None
search_output_file: True
input_dir: ''
fit_method: median
fit_by_channel: False
background_method: median
background_box_size: None
mask_science_regions: False
apply_flat_field: False
n_sigma: 2.0
fit_histogram: False
single_mask: True
user_mask: None
save_mask: False
save_background: False
save_noise: False
ramp_fit:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
algorithm: OLS_C
int_name: ''
save_opt: False
opt_name: ''
suppress_one_group: True
firstgroup: None
lastgroup: None
maximum_cores: '1'
gain_scale:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
2025-09-13 16:17:00,800 - stpipe.Detector1Pipeline - INFO - Prefetching reference files for dataset: 'jw02079004003_05101_00001_nis_uncal.fits' reftypes = ['dark', 'gain', 'linearity', 'mask', 'persat', 'readnoise', 'refpix', 'reset', 'rscd', 'saturation', 'sirskernel', 'superbias', 'trapdensity', 'trappars']
2025-09-13 16:17:00,803 - stpipe.Detector1Pipeline - INFO - Prefetch for DARK reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_dark_0228.fits'.
2025-09-13 16:17:00,804 - stpipe.Detector1Pipeline - INFO - Prefetch for GAIN reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_gain_0006.fits'.
2025-09-13 16:17:00,804 - stpipe.Detector1Pipeline - INFO - Prefetch for LINEARITY reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_linearity_0017.fits'.
2025-09-13 16:17:00,804 - stpipe.Detector1Pipeline - INFO - Prefetch for MASK reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_mask_0035.fits'.
2025-09-13 16:17:00,805 - stpipe.Detector1Pipeline - INFO - Prefetch for PERSAT reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_persat_0004.fits'.
2025-09-13 16:17:00,805 - stpipe.Detector1Pipeline - INFO - Prefetch for READNOISE reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_readnoise_0005.fits'.
2025-09-13 16:17:00,806 - stpipe.Detector1Pipeline - INFO - Prefetch for REFPIX reference file is 'N/A'.
2025-09-13 16:17:00,806 - stpipe.Detector1Pipeline - INFO - Prefetch for RESET reference file is 'N/A'.
2025-09-13 16:17:00,806 - stpipe.Detector1Pipeline - INFO - Prefetch for RSCD reference file is 'N/A'.
2025-09-13 16:17:00,807 - stpipe.Detector1Pipeline - INFO - Prefetch for SATURATION reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_saturation_0015.fits'.
2025-09-13 16:17:00,807 - stpipe.Detector1Pipeline - INFO - Prefetch for SIRSKERNEL reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_sirskernel_0001.asdf'.
2025-09-13 16:17:00,808 - stpipe.Detector1Pipeline - INFO - Prefetch for SUPERBIAS reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_superbias_0238.fits'.
2025-09-13 16:17:00,808 - stpipe.Detector1Pipeline - INFO - Prefetch for TRAPDENSITY reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_trapdensity_0002.fits'.
2025-09-13 16:17:00,808 - stpipe.Detector1Pipeline - INFO - Prefetch for TRAPPARS reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_trappars_0002.fits'.
2025-09-13 16:17:00,809 - jwst.pipeline.calwebb_detector1 - INFO - Starting calwebb_detector1 ...
2025-09-13 16:17:01,934 - stpipe.Detector1Pipeline.group_scale - INFO - Step group_scale running with args (<RampModel(6, 20, 2048, 2048) from jw02079004003_05101_00001_nis_uncal.fits>,).
2025-09-13 16:17:01,941 - stpipe.Detector1Pipeline.group_scale - INFO - NFRAMES and FRMDIVSR are equal; correction not needed
2025-09-13 16:17:01,942 - stpipe.Detector1Pipeline.group_scale - INFO - Step will be skipped
2025-09-13 16:17:01,943 - stpipe.Detector1Pipeline.group_scale - INFO - Step group_scale done
2025-09-13 16:17:02,121 - stpipe.Detector1Pipeline.dq_init - INFO - Step dq_init running with args (<RampModel(6, 20, 2048, 2048) from jw02079004003_05101_00001_nis_uncal.fits>,).
2025-09-13 16:17:02,130 - stpipe.Detector1Pipeline.dq_init - INFO - Using MASK reference file /home/runner/crds/references/jwst/niriss/jwst_niriss_mask_0035.fits
2025-09-13 16:17:03,097 - stpipe.Detector1Pipeline.dq_init - INFO - Step dq_init done
2025-09-13 16:17:03,283 - stpipe.Detector1Pipeline.saturation - INFO - Step saturation running with args (<RampModel(6, 20, 2048, 2048) from jw02079004003_05101_00001_nis_uncal.fits>,).
2025-09-13 16:17:03,295 - stpipe.Detector1Pipeline.saturation - INFO - Using SATURATION reference file /home/runner/crds/references/jwst/niriss/jwst_niriss_saturation_0015.fits
2025-09-13 16:17:03,295 - stpipe.Detector1Pipeline.saturation - INFO - Using SUPERBIAS reference file /home/runner/crds/references/jwst/niriss/jwst_niriss_superbias_0238.fits
2025-09-13 16:17:03,322 - stdatamodels.dynamicdq - WARNING - Keyword LOWILLUM does not correspond to an existing DQ mnemonic, so will be ignored
2025-09-13 16:17:03,323 - stdatamodels.dynamicdq - WARNING - Keyword LOWRESP does not correspond to an existing DQ mnemonic, so will be ignored
2025-09-13 16:17:03,327 - stdatamodels.dynamicdq - WARNING - Keyword UNCERTAIN does not correspond to an existing DQ mnemonic, so will be ignored
2025-09-13 16:17:03,746 - jwst.saturation.saturation - INFO - Using read_pattern with nframes 4
2025-09-13 16:17:09,798 - stcal.saturation.saturation - INFO - Detected 20016 saturated pixels
2025-09-13 16:17:09,929 - stcal.saturation.saturation - INFO - Detected 3 A/D floor pixels
2025-09-13 16:17:09,934 - stpipe.Detector1Pipeline.saturation - INFO - Step saturation done
2025-09-13 16:17:10,119 - stpipe.Detector1Pipeline.ipc - INFO - Step ipc running with args (<RampModel(6, 20, 2048, 2048) from jw02079004003_05101_00001_nis_uncal.fits>,).
2025-09-13 16:17:10,119 - stpipe.Detector1Pipeline.ipc - INFO - Step skipped.
2025-09-13 16:17:10,291 - stpipe.Detector1Pipeline.superbias - INFO - Step superbias running with args (<RampModel(6, 20, 2048, 2048) from jw02079004003_05101_00001_nis_uncal.fits>,).
2025-09-13 16:17:10,301 - stpipe.Detector1Pipeline.superbias - INFO - Using SUPERBIAS reference file /home/runner/crds/references/jwst/niriss/jwst_niriss_superbias_0238.fits
2025-09-13 16:17:11,940 - stpipe.Detector1Pipeline.superbias - INFO - Step superbias done
2025-09-13 16:17:12,103 - stpipe.Detector1Pipeline.refpix - INFO - Step refpix running with args (<RampModel(6, 20, 2048, 2048) from jw02079004003_05101_00001_nis_uncal.fits>,).
2025-09-13 16:17:12,458 - jwst.refpix.reference_pixels - INFO - NIR full frame data
2025-09-13 16:17:12,459 - jwst.refpix.reference_pixels - INFO - The following parameters are valid for this mode:
2025-09-13 16:17:12,460 - jwst.refpix.reference_pixels - INFO - use_side_ref_pixels = True
2025-09-13 16:17:12,460 - jwst.refpix.reference_pixels - INFO - odd_even_columns = True
2025-09-13 16:17:12,460 - jwst.refpix.reference_pixels - INFO - side_smoothing_length = 11
2025-09-13 16:17:12,461 - jwst.refpix.reference_pixels - INFO - side_gain = 1.0
2025-09-13 16:17:12,461 - jwst.refpix.reference_pixels - INFO - The following parameter is not applicable and is ignored:
2025-09-13 16:17:12,461 - jwst.refpix.reference_pixels - INFO - odd_even_rows = False
2025-09-13 16:17:42,817 - stpipe.Detector1Pipeline.refpix - INFO - Step refpix done
2025-09-13 16:17:43,001 - stpipe.Detector1Pipeline.linearity - INFO - Step linearity running with args (<RampModel(6, 20, 2048, 2048) from jw02079004003_05101_00001_nis_uncal.fits>,).
2025-09-13 16:17:43,010 - stpipe.Detector1Pipeline.linearity - INFO - Using Linearity reference file /home/runner/crds/references/jwst/niriss/jwst_niriss_linearity_0017.fits
2025-09-13 16:17:43,055 - stdatamodels.dynamicdq - WARNING - Keyword LOWILLUM does not correspond to an existing DQ mnemonic, so will be ignored
2025-09-13 16:17:43,056 - stdatamodels.dynamicdq - WARNING - Keyword LOWRESP does not correspond to an existing DQ mnemonic, so will be ignored
2025-09-13 16:17:43,060 - stdatamodels.dynamicdq - WARNING - Keyword UNCERTAIN does not correspond to an existing DQ mnemonic, so will be ignored
2025-09-13 16:17:47,231 - stpipe.Detector1Pipeline.linearity - INFO - Step linearity done
2025-09-13 16:17:47,416 - stpipe.Detector1Pipeline.persistence - INFO - Step persistence running with args (<RampModel(6, 20, 2048, 2048) from jw02079004003_05101_00001_nis_uncal.fits>,).
2025-09-13 16:18:09,502 - stpipe.Detector1Pipeline.persistence - INFO - Saved model in /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage1/jw02079004003_05101_00001_nis_trapsfilled.fits
2025-09-13 16:18:09,505 - stpipe.Detector1Pipeline.persistence - INFO - Step persistence done
2025-09-13 16:18:09,693 - stpipe.Detector1Pipeline.dark_current - INFO - Step dark_current running with args (<RampModel(6, 20, 2048, 2048) from jw02079004003_05101_00001_nis_uncal.fits>,).
2025-09-13 16:18:09,702 - stpipe.Detector1Pipeline.dark_current - INFO - Using DARK reference file /home/runner/crds/references/jwst/niriss/jwst_niriss_dark_0228.fits
2025-09-13 16:18:10,254 - stcal.dark_current.dark_sub - INFO - Science data nints=6, ngroups=20, nframes=4, groupgap=0
2025-09-13 16:18:10,255 - stcal.dark_current.dark_sub - INFO - Dark data nints=1, ngroups=30, nframes=4, groupgap=0
2025-09-13 16:18:11,139 - stpipe.Detector1Pipeline.dark_current - INFO - Step dark_current done
2025-09-13 16:18:11,331 - stpipe.Detector1Pipeline.charge_migration - INFO - Step charge_migration running with args (<RampModel(6, 20, 2048, 2048) from jw02079004003_05101_00001_nis_uncal.fits>,).
2025-09-13 16:18:11,701 - jwst.charge_migration.charge_migration - INFO - Using signal_threshold: 22314.00
2025-09-13 16:18:15,129 - stpipe.Detector1Pipeline.charge_migration - INFO - Step charge_migration done
2025-09-13 16:18:15,310 - stpipe.Detector1Pipeline.jump - INFO - Step jump running with args (<RampModel(6, 20, 2048, 2048) from jw02079004003_05101_00001_nis_uncal.fits>,).
2025-09-13 16:18:15,318 - stpipe.Detector1Pipeline.jump - INFO - CR rejection threshold = 6 sigma
2025-09-13 16:18:15,318 - stpipe.Detector1Pipeline.jump - INFO - Maximum cores to use = 1
2025-09-13 16:18:15,691 - stpipe.Detector1Pipeline.jump - INFO - Using GAIN reference file: /home/runner/crds/references/jwst/niriss/jwst_niriss_gain_0006.fits
2025-09-13 16:18:15,693 - stpipe.Detector1Pipeline.jump - INFO - Using READNOISE reference file: /home/runner/crds/references/jwst/niriss/jwst_niriss_readnoise_0005.fits
2025-09-13 16:18:16,372 - stcal.jump.jump - INFO - Executing two-point difference method
2025-09-13 16:18:45,116 - stcal.jump.jump - INFO - Flagging Snowballs
2025-09-13 16:18:47,527 - stcal.jump.jump - INFO - Total snowballs = 725
2025-09-13 16:18:47,528 - stcal.jump.jump - INFO - Total elapsed time = 31.1553 sec
2025-09-13 16:18:48,010 - stpipe.Detector1Pipeline.jump - INFO - The execution time in seconds: 32.692050
2025-09-13 16:18:48,013 - stpipe.Detector1Pipeline.jump - INFO - Step jump done
2025-09-13 16:18:48,192 - stpipe.Detector1Pipeline.clean_flicker_noise - INFO - Step clean_flicker_noise running with args (<RampModel(6, 20, 2048, 2048) from jw02079004003_05101_00001_nis_uncal.fits>,).
2025-09-13 16:18:48,193 - stpipe.Detector1Pipeline.clean_flicker_noise - INFO - Step skipped.
2025-09-13 16:18:48,363 - stpipe.Detector1Pipeline.ramp_fit - INFO - Step ramp_fit running with args (<RampModel(6, 20, 2048, 2048) from jw02079004003_05101_00001_nis_uncal.fits>,).
2025-09-13 16:18:48,713 - jwst.ramp_fitting.ramp_fit_step - INFO - Using READNOISE reference file: /home/runner/crds/references/jwst/niriss/jwst_niriss_readnoise_0005.fits
2025-09-13 16:18:48,714 - jwst.ramp_fitting.ramp_fit_step - INFO - Using GAIN reference file: /home/runner/crds/references/jwst/niriss/jwst_niriss_gain_0006.fits
2025-09-13 16:18:48,740 - jwst.ramp_fitting.ramp_fit_step - INFO - Using algorithm = OLS_C
2025-09-13 16:18:48,740 - jwst.ramp_fitting.ramp_fit_step - INFO - Using weighting = optimal
2025-09-13 16:18:50,333 - stcal.ramp_fitting.ols_fit - INFO - Number of multiprocessing slices: 1
2025-09-13 16:19:30,287 - stcal.ramp_fitting.ols_fit - INFO - Ramp Fitting C Time: 39.94658708572388
2025-09-13 16:19:30,335 - stpipe.Detector1Pipeline.ramp_fit - INFO - Step ramp_fit done
2025-09-13 16:19:30,511 - stpipe.Detector1Pipeline.gain_scale - INFO - Step gain_scale running with args (<ImageModel(2048, 2048) from jw02079004003_05101_00001_nis_uncal.fits>,).
2025-09-13 16:19:30,531 - stpipe.Detector1Pipeline.gain_scale - INFO - GAINFACT not found in gain reference file
2025-09-13 16:19:30,532 - stpipe.Detector1Pipeline.gain_scale - INFO - Step will be skipped
2025-09-13 16:19:30,534 - stpipe.Detector1Pipeline.gain_scale - INFO - Step gain_scale done
2025-09-13 16:19:30,698 - stpipe.Detector1Pipeline.gain_scale - INFO - Step gain_scale running with args (<CubeModel(6, 2048, 2048) from jw02079004003_05101_00001_nis_uncal.fits>,).
2025-09-13 16:19:30,719 - stpipe.Detector1Pipeline.gain_scale - INFO - GAINFACT not found in gain reference file
2025-09-13 16:19:30,719 - stpipe.Detector1Pipeline.gain_scale - INFO - Step will be skipped
2025-09-13 16:19:30,721 - stpipe.Detector1Pipeline.gain_scale - INFO - Step gain_scale done
2025-09-13 16:19:31,147 - stpipe.Detector1Pipeline - INFO - Saved model in /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage1/jw02079004003_05101_00001_nis_rateints.fits
2025-09-13 16:19:31,148 - jwst.pipeline.calwebb_detector1 - INFO - ... ending calwebb_detector1
2025-09-13 16:19:31,150 - jwst.stpipe.core - INFO - Results used CRDS context: jwst_1413.pmap
2025-09-13 16:19:31,257 - stpipe.Detector1Pipeline - INFO - Saved model in /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage1/jw02079004003_05101_00001_nis_rate.fits
2025-09-13 16:19:31,258 - stpipe.Detector1Pipeline - INFO - Step Detector1Pipeline done
2025-09-13 16:19:31,258 - jwst.stpipe.core - INFO - Results used jwst version: 1.19.1
2025-09-13 16:19:31,287 - CRDS - ERROR - Error determining best reference for 'pars-darkcurrentstep' = No match found.
2025-09-13 16:19:31,291 - stpipe - INFO - PARS-CHARGEMIGRATIONSTEP parameters found: /home/runner/crds/references/jwst/niriss/jwst_niriss_pars-chargemigrationstep_0001.asdf
2025-09-13 16:19:31,299 - stpipe - INFO - PARS-JUMPSTEP parameters found: /home/runner/crds/references/jwst/niriss/jwst_niriss_pars-jumpstep_0091.asdf
2025-09-13 16:19:31,309 - stpipe - INFO - PARS-DETECTOR1PIPELINE parameters found: /home/runner/crds/references/jwst/niriss/jwst_niriss_pars-detector1pipeline_0001.asdf
2025-09-13 16:19:31,324 - stpipe.Detector1Pipeline - INFO - Detector1Pipeline instance created.
2025-09-13 16:19:31,325 - stpipe.Detector1Pipeline.group_scale - INFO - GroupScaleStep instance created.
2025-09-13 16:19:31,325 - stpipe.Detector1Pipeline.dq_init - INFO - DQInitStep instance created.
2025-09-13 16:19:31,326 - stpipe.Detector1Pipeline.emicorr - INFO - EmiCorrStep instance created.
2025-09-13 16:19:31,327 - stpipe.Detector1Pipeline.saturation - INFO - SaturationStep instance created.
2025-09-13 16:19:31,328 - stpipe.Detector1Pipeline.ipc - INFO - IPCStep instance created.
2025-09-13 16:19:31,329 - stpipe.Detector1Pipeline.superbias - INFO - SuperBiasStep instance created.
2025-09-13 16:19:31,330 - stpipe.Detector1Pipeline.refpix - INFO - RefPixStep instance created.
2025-09-13 16:19:31,330 - stpipe.Detector1Pipeline.rscd - INFO - RscdStep instance created.
2025-09-13 16:19:31,331 - stpipe.Detector1Pipeline.firstframe - INFO - FirstFrameStep instance created.
2025-09-13 16:19:31,332 - stpipe.Detector1Pipeline.lastframe - INFO - LastFrameStep instance created.
2025-09-13 16:19:31,332 - stpipe.Detector1Pipeline.linearity - INFO - LinearityStep instance created.
2025-09-13 16:19:31,333 - stpipe.Detector1Pipeline.dark_current - INFO - DarkCurrentStep instance created.
2025-09-13 16:19:31,334 - stpipe.Detector1Pipeline.reset - INFO - ResetStep instance created.
2025-09-13 16:19:31,335 - stpipe.Detector1Pipeline.persistence - INFO - PersistenceStep instance created.
2025-09-13 16:19:31,335 - stpipe.Detector1Pipeline.charge_migration - INFO - ChargeMigrationStep instance created.
2025-09-13 16:19:31,337 - stpipe.Detector1Pipeline.jump - INFO - JumpStep instance created.
2025-09-13 16:19:31,338 - stpipe.Detector1Pipeline.clean_flicker_noise - INFO - CleanFlickerNoiseStep instance created.
2025-09-13 16:19:31,339 - stpipe.Detector1Pipeline.ramp_fit - INFO - RampFitStep instance created.
2025-09-13 16:19:31,340 - stpipe.Detector1Pipeline.gain_scale - INFO - GainScaleStep instance created.
2025-09-13 16:19:31,507 - stpipe.Detector1Pipeline - INFO - Step Detector1Pipeline running with args ('/home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/uncal/jw02079004003_05101_00002_nis_uncal.fits',).
2025-09-13 16:19:31,528 - stpipe.Detector1Pipeline - INFO - Step Detector1Pipeline parameters are:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage1
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: True
skip: False
suffix: None
search_output_file: True
input_dir: ''
save_calibrated_ramp: False
steps:
group_scale:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
dq_init:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
emicorr:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: True
suffix: None
search_output_file: True
input_dir: ''
algorithm: joint
nints_to_phase: None
nbins: None
scale_reference: True
onthefly_corr_freq: None
use_n_cycles: 3
fit_ints_separately: False
user_supplied_reffile: None
save_intermediate_results: False
saturation:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
n_pix_grow_sat: 1
use_readpatt: True
ipc:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: True
suffix: None
search_output_file: True
input_dir: ''
superbias:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
refpix:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
odd_even_columns: True
use_side_ref_pixels: True
side_smoothing_length: 11
side_gain: 1.0
odd_even_rows: True
ovr_corr_mitigation_ftr: 3.0
preserve_irs2_refpix: False
irs2_mean_subtraction: False
refpix_algorithm: median
sigreject: 4.0
gaussmooth: 1.0
halfwidth: 30
rscd:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
firstframe:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
bright_use_group1: False
lastframe:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
linearity:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
dark_current:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
dark_output: None
average_dark_current: None
reset:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
persistence:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
input_trapsfilled: ''
flag_pers_cutoff: 40.0
save_persistence: False
save_trapsfilled: True
modify_input: False
charge_migration:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
signal_threshold: 22314.0
jump:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
rejection_threshold: 6.0
three_group_rejection_threshold: 6.0
four_group_rejection_threshold: 5.0
maximum_cores: '1'
flag_4_neighbors: False
max_jump_to_flag_neighbors: 200.0
min_jump_to_flag_neighbors: 10.0
after_jump_flag_dn1: 1000
after_jump_flag_time1: 90
after_jump_flag_dn2: 0
after_jump_flag_time2: 0
expand_large_events: True
min_sat_area: 5
min_jump_area: 15.0
expand_factor: 1.75
use_ellipses: False
sat_required_snowball: True
min_sat_radius_extend: 5.0
sat_expand: 0
edge_size: 20
mask_snowball_core_next_int: True
snowball_time_masked_next_int: 4000
find_showers: False
max_shower_amplitude: 4.0
extend_snr_threshold: 1.2
extend_min_area: 90
extend_inner_radius: 1.0
extend_outer_radius: 2.6
extend_ellipse_expand_ratio: 1.1
time_masked_after_shower: 15.0
min_diffs_single_pass: 10
max_extended_radius: 100
minimum_groups: 3
minimum_sigclip_groups: 100
only_use_ints: True
clean_flicker_noise:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: True
suffix: None
search_output_file: True
input_dir: ''
fit_method: median
fit_by_channel: False
background_method: median
background_box_size: None
mask_science_regions: False
apply_flat_field: False
n_sigma: 2.0
fit_histogram: False
single_mask: True
user_mask: None
save_mask: False
save_background: False
save_noise: False
ramp_fit:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
algorithm: OLS_C
int_name: ''
save_opt: False
opt_name: ''
suppress_one_group: True
firstgroup: None
lastgroup: None
maximum_cores: '1'
gain_scale:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
2025-09-13 16:19:31,547 - stpipe.Detector1Pipeline - INFO - Prefetching reference files for dataset: 'jw02079004003_05101_00002_nis_uncal.fits' reftypes = ['dark', 'gain', 'linearity', 'mask', 'persat', 'readnoise', 'refpix', 'reset', 'rscd', 'saturation', 'sirskernel', 'superbias', 'trapdensity', 'trappars']
2025-09-13 16:19:31,550 - stpipe.Detector1Pipeline - INFO - Prefetch for DARK reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_dark_0228.fits'.
2025-09-13 16:19:31,550 - stpipe.Detector1Pipeline - INFO - Prefetch for GAIN reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_gain_0006.fits'.
2025-09-13 16:19:31,550 - stpipe.Detector1Pipeline - INFO - Prefetch for LINEARITY reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_linearity_0017.fits'.
2025-09-13 16:19:31,551 - stpipe.Detector1Pipeline - INFO - Prefetch for MASK reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_mask_0035.fits'.
2025-09-13 16:19:31,551 - stpipe.Detector1Pipeline - INFO - Prefetch for PERSAT reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_persat_0004.fits'.
2025-09-13 16:19:31,551 - stpipe.Detector1Pipeline - INFO - Prefetch for READNOISE reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_readnoise_0005.fits'.
2025-09-13 16:19:31,552 - stpipe.Detector1Pipeline - INFO - Prefetch for REFPIX reference file is 'N/A'.
2025-09-13 16:19:31,552 - stpipe.Detector1Pipeline - INFO - Prefetch for RESET reference file is 'N/A'.
2025-09-13 16:19:31,552 - stpipe.Detector1Pipeline - INFO - Prefetch for RSCD reference file is 'N/A'.
2025-09-13 16:19:31,552 - stpipe.Detector1Pipeline - INFO - Prefetch for SATURATION reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_saturation_0015.fits'.
2025-09-13 16:19:31,553 - stpipe.Detector1Pipeline - INFO - Prefetch for SIRSKERNEL reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_sirskernel_0001.asdf'.
2025-09-13 16:19:31,553 - stpipe.Detector1Pipeline - INFO - Prefetch for SUPERBIAS reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_superbias_0238.fits'.
2025-09-13 16:19:31,553 - stpipe.Detector1Pipeline - INFO - Prefetch for TRAPDENSITY reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_trapdensity_0002.fits'.
2025-09-13 16:19:31,554 - stpipe.Detector1Pipeline - INFO - Prefetch for TRAPPARS reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_trappars_0002.fits'.
2025-09-13 16:19:31,554 - jwst.pipeline.calwebb_detector1 - INFO - Starting calwebb_detector1 ...
2025-09-13 16:19:32,657 - stpipe.Detector1Pipeline.group_scale - INFO - Step group_scale running with args (<RampModel(6, 20, 2048, 2048) from jw02079004003_05101_00002_nis_uncal.fits>,).
2025-09-13 16:19:32,664 - stpipe.Detector1Pipeline.group_scale - INFO - NFRAMES and FRMDIVSR are equal; correction not needed
2025-09-13 16:19:32,665 - stpipe.Detector1Pipeline.group_scale - INFO - Step will be skipped
2025-09-13 16:19:32,666 - stpipe.Detector1Pipeline.group_scale - INFO - Step group_scale done
2025-09-13 16:19:32,839 - stpipe.Detector1Pipeline.dq_init - INFO - Step dq_init running with args (<RampModel(6, 20, 2048, 2048) from jw02079004003_05101_00002_nis_uncal.fits>,).
2025-09-13 16:19:32,848 - stpipe.Detector1Pipeline.dq_init - INFO - Using MASK reference file /home/runner/crds/references/jwst/niriss/jwst_niriss_mask_0035.fits
2025-09-13 16:19:33,749 - stpipe.Detector1Pipeline.dq_init - INFO - Step dq_init done
2025-09-13 16:19:33,927 - stpipe.Detector1Pipeline.saturation - INFO - Step saturation running with args (<RampModel(6, 20, 2048, 2048) from jw02079004003_05101_00002_nis_uncal.fits>,).
2025-09-13 16:19:33,937 - stpipe.Detector1Pipeline.saturation - INFO - Using SATURATION reference file /home/runner/crds/references/jwst/niriss/jwst_niriss_saturation_0015.fits
2025-09-13 16:19:33,937 - stpipe.Detector1Pipeline.saturation - INFO - Using SUPERBIAS reference file /home/runner/crds/references/jwst/niriss/jwst_niriss_superbias_0238.fits
2025-09-13 16:19:33,963 - stdatamodels.dynamicdq - WARNING - Keyword LOWILLUM does not correspond to an existing DQ mnemonic, so will be ignored
2025-09-13 16:19:33,964 - stdatamodels.dynamicdq - WARNING - Keyword LOWRESP does not correspond to an existing DQ mnemonic, so will be ignored
2025-09-13 16:19:33,968 - stdatamodels.dynamicdq - WARNING - Keyword UNCERTAIN does not correspond to an existing DQ mnemonic, so will be ignored
2025-09-13 16:19:34,347 - jwst.saturation.saturation - INFO - Using read_pattern with nframes 4
2025-09-13 16:19:40,368 - stcal.saturation.saturation - INFO - Detected 19829 saturated pixels
2025-09-13 16:19:40,497 - stcal.saturation.saturation - INFO - Detected 5 A/D floor pixels
2025-09-13 16:19:40,503 - stpipe.Detector1Pipeline.saturation - INFO - Step saturation done
2025-09-13 16:19:40,682 - stpipe.Detector1Pipeline.ipc - INFO - Step ipc running with args (<RampModel(6, 20, 2048, 2048) from jw02079004003_05101_00002_nis_uncal.fits>,).
2025-09-13 16:19:40,683 - stpipe.Detector1Pipeline.ipc - INFO - Step skipped.
2025-09-13 16:19:40,848 - stpipe.Detector1Pipeline.superbias - INFO - Step superbias running with args (<RampModel(6, 20, 2048, 2048) from jw02079004003_05101_00002_nis_uncal.fits>,).
2025-09-13 16:19:40,857 - stpipe.Detector1Pipeline.superbias - INFO - Using SUPERBIAS reference file /home/runner/crds/references/jwst/niriss/jwst_niriss_superbias_0238.fits
2025-09-13 16:19:42,478 - stpipe.Detector1Pipeline.superbias - INFO - Step superbias done
2025-09-13 16:19:42,664 - stpipe.Detector1Pipeline.refpix - INFO - Step refpix running with args (<RampModel(6, 20, 2048, 2048) from jw02079004003_05101_00002_nis_uncal.fits>,).
2025-09-13 16:19:43,012 - jwst.refpix.reference_pixels - INFO - NIR full frame data
2025-09-13 16:19:43,013 - jwst.refpix.reference_pixels - INFO - The following parameters are valid for this mode:
2025-09-13 16:19:43,013 - jwst.refpix.reference_pixels - INFO - use_side_ref_pixels = True
2025-09-13 16:19:43,014 - jwst.refpix.reference_pixels - INFO - odd_even_columns = True
2025-09-13 16:19:43,014 - jwst.refpix.reference_pixels - INFO - side_smoothing_length = 11
2025-09-13 16:19:43,014 - jwst.refpix.reference_pixels - INFO - side_gain = 1.0
2025-09-13 16:19:43,015 - jwst.refpix.reference_pixels - INFO - The following parameter is not applicable and is ignored:
2025-09-13 16:19:43,015 - jwst.refpix.reference_pixels - INFO - odd_even_rows = False
2025-09-13 16:20:13,159 - stpipe.Detector1Pipeline.refpix - INFO - Step refpix done
2025-09-13 16:20:13,346 - stpipe.Detector1Pipeline.linearity - INFO - Step linearity running with args (<RampModel(6, 20, 2048, 2048) from jw02079004003_05101_00002_nis_uncal.fits>,).
2025-09-13 16:20:13,356 - stpipe.Detector1Pipeline.linearity - INFO - Using Linearity reference file /home/runner/crds/references/jwst/niriss/jwst_niriss_linearity_0017.fits
2025-09-13 16:20:13,402 - stdatamodels.dynamicdq - WARNING - Keyword LOWILLUM does not correspond to an existing DQ mnemonic, so will be ignored
2025-09-13 16:20:13,403 - stdatamodels.dynamicdq - WARNING - Keyword LOWRESP does not correspond to an existing DQ mnemonic, so will be ignored
2025-09-13 16:20:13,407 - stdatamodels.dynamicdq - WARNING - Keyword UNCERTAIN does not correspond to an existing DQ mnemonic, so will be ignored
2025-09-13 16:20:17,673 - stpipe.Detector1Pipeline.linearity - INFO - Step linearity done
2025-09-13 16:20:17,870 - stpipe.Detector1Pipeline.persistence - INFO - Step persistence running with args (<RampModel(6, 20, 2048, 2048) from jw02079004003_05101_00002_nis_uncal.fits>,).
2025-09-13 16:20:39,764 - stpipe.Detector1Pipeline.persistence - INFO - Saved model in /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage1/jw02079004003_05101_00002_nis_trapsfilled.fits
2025-09-13 16:20:39,767 - stpipe.Detector1Pipeline.persistence - INFO - Step persistence done
2025-09-13 16:20:39,956 - stpipe.Detector1Pipeline.dark_current - INFO - Step dark_current running with args (<RampModel(6, 20, 2048, 2048) from jw02079004003_05101_00002_nis_uncal.fits>,).
2025-09-13 16:20:39,966 - stpipe.Detector1Pipeline.dark_current - INFO - Using DARK reference file /home/runner/crds/references/jwst/niriss/jwst_niriss_dark_0228.fits
2025-09-13 16:20:40,514 - stcal.dark_current.dark_sub - INFO - Science data nints=6, ngroups=20, nframes=4, groupgap=0
2025-09-13 16:20:40,515 - stcal.dark_current.dark_sub - INFO - Dark data nints=1, ngroups=30, nframes=4, groupgap=0
2025-09-13 16:20:41,396 - stpipe.Detector1Pipeline.dark_current - INFO - Step dark_current done
2025-09-13 16:20:41,585 - stpipe.Detector1Pipeline.charge_migration - INFO - Step charge_migration running with args (<RampModel(6, 20, 2048, 2048) from jw02079004003_05101_00002_nis_uncal.fits>,).
2025-09-13 16:20:41,945 - jwst.charge_migration.charge_migration - INFO - Using signal_threshold: 22314.00
2025-09-13 16:20:45,308 - stpipe.Detector1Pipeline.charge_migration - INFO - Step charge_migration done
2025-09-13 16:20:45,491 - stpipe.Detector1Pipeline.jump - INFO - Step jump running with args (<RampModel(6, 20, 2048, 2048) from jw02079004003_05101_00002_nis_uncal.fits>,).
2025-09-13 16:20:45,498 - stpipe.Detector1Pipeline.jump - INFO - CR rejection threshold = 6 sigma
2025-09-13 16:20:45,499 - stpipe.Detector1Pipeline.jump - INFO - Maximum cores to use = 1
2025-09-13 16:20:45,864 - stpipe.Detector1Pipeline.jump - INFO - Using GAIN reference file: /home/runner/crds/references/jwst/niriss/jwst_niriss_gain_0006.fits
2025-09-13 16:20:45,867 - stpipe.Detector1Pipeline.jump - INFO - Using READNOISE reference file: /home/runner/crds/references/jwst/niriss/jwst_niriss_readnoise_0005.fits
2025-09-13 16:20:46,547 - stcal.jump.jump - INFO - Executing two-point difference method
2025-09-13 16:21:13,750 - stcal.jump.jump - INFO - Flagging Snowballs
2025-09-13 16:21:16,201 - stcal.jump.jump - INFO - Total snowballs = 709
2025-09-13 16:21:16,202 - stcal.jump.jump - INFO - Total elapsed time = 29.6546 sec
2025-09-13 16:21:16,693 - stpipe.Detector1Pipeline.jump - INFO - The execution time in seconds: 31.194017
2025-09-13 16:21:16,695 - stpipe.Detector1Pipeline.jump - INFO - Step jump done
2025-09-13 16:21:16,880 - stpipe.Detector1Pipeline.clean_flicker_noise - INFO - Step clean_flicker_noise running with args (<RampModel(6, 20, 2048, 2048) from jw02079004003_05101_00002_nis_uncal.fits>,).
2025-09-13 16:21:16,880 - stpipe.Detector1Pipeline.clean_flicker_noise - INFO - Step skipped.
2025-09-13 16:21:17,056 - stpipe.Detector1Pipeline.ramp_fit - INFO - Step ramp_fit running with args (<RampModel(6, 20, 2048, 2048) from jw02079004003_05101_00002_nis_uncal.fits>,).
2025-09-13 16:21:17,426 - jwst.ramp_fitting.ramp_fit_step - INFO - Using READNOISE reference file: /home/runner/crds/references/jwst/niriss/jwst_niriss_readnoise_0005.fits
2025-09-13 16:21:17,427 - jwst.ramp_fitting.ramp_fit_step - INFO - Using GAIN reference file: /home/runner/crds/references/jwst/niriss/jwst_niriss_gain_0006.fits
2025-09-13 16:21:17,452 - jwst.ramp_fitting.ramp_fit_step - INFO - Using algorithm = OLS_C
2025-09-13 16:21:17,453 - jwst.ramp_fitting.ramp_fit_step - INFO - Using weighting = optimal
2025-09-13 16:21:19,067 - stcal.ramp_fitting.ols_fit - INFO - Number of multiprocessing slices: 1
2025-09-13 16:21:58,865 - stcal.ramp_fitting.ols_fit - INFO - Ramp Fitting C Time: 39.79085373878479
2025-09-13 16:21:58,914 - stpipe.Detector1Pipeline.ramp_fit - INFO - Step ramp_fit done
2025-09-13 16:21:59,105 - stpipe.Detector1Pipeline.gain_scale - INFO - Step gain_scale running with args (<ImageModel(2048, 2048) from jw02079004003_05101_00002_nis_uncal.fits>,).
2025-09-13 16:21:59,126 - stpipe.Detector1Pipeline.gain_scale - INFO - GAINFACT not found in gain reference file
2025-09-13 16:21:59,126 - stpipe.Detector1Pipeline.gain_scale - INFO - Step will be skipped
2025-09-13 16:21:59,128 - stpipe.Detector1Pipeline.gain_scale - INFO - Step gain_scale done
2025-09-13 16:21:59,315 - stpipe.Detector1Pipeline.gain_scale - INFO - Step gain_scale running with args (<CubeModel(6, 2048, 2048) from jw02079004003_05101_00002_nis_uncal.fits>,).
2025-09-13 16:21:59,336 - stpipe.Detector1Pipeline.gain_scale - INFO - GAINFACT not found in gain reference file
2025-09-13 16:21:59,336 - stpipe.Detector1Pipeline.gain_scale - INFO - Step will be skipped
2025-09-13 16:21:59,338 - stpipe.Detector1Pipeline.gain_scale - INFO - Step gain_scale done
2025-09-13 16:21:59,769 - stpipe.Detector1Pipeline - INFO - Saved model in /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage1/jw02079004003_05101_00002_nis_rateints.fits
2025-09-13 16:21:59,770 - jwst.pipeline.calwebb_detector1 - INFO - ... ending calwebb_detector1
2025-09-13 16:21:59,773 - jwst.stpipe.core - INFO - Results used CRDS context: jwst_1413.pmap
2025-09-13 16:21:59,883 - stpipe.Detector1Pipeline - INFO - Saved model in /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage1/jw02079004003_05101_00002_nis_rate.fits
2025-09-13 16:21:59,884 - stpipe.Detector1Pipeline - INFO - Step Detector1Pipeline done
2025-09-13 16:21:59,884 - jwst.stpipe.core - INFO - Results used jwst version: 1.19.1
2025-09-13 16:21:59,914 - CRDS - ERROR - Error determining best reference for 'pars-darkcurrentstep' = No match found.
2025-09-13 16:21:59,917 - stpipe - INFO - PARS-CHARGEMIGRATIONSTEP parameters found: /home/runner/crds/references/jwst/niriss/jwst_niriss_pars-chargemigrationstep_0001.asdf
2025-09-13 16:21:59,925 - stpipe - INFO - PARS-JUMPSTEP parameters found: /home/runner/crds/references/jwst/niriss/jwst_niriss_pars-jumpstep_0091.asdf
2025-09-13 16:21:59,936 - stpipe - INFO - PARS-DETECTOR1PIPELINE parameters found: /home/runner/crds/references/jwst/niriss/jwst_niriss_pars-detector1pipeline_0001.asdf
2025-09-13 16:21:59,951 - stpipe.Detector1Pipeline - INFO - Detector1Pipeline instance created.
2025-09-13 16:21:59,952 - stpipe.Detector1Pipeline.group_scale - INFO - GroupScaleStep instance created.
2025-09-13 16:21:59,953 - stpipe.Detector1Pipeline.dq_init - INFO - DQInitStep instance created.
2025-09-13 16:21:59,954 - stpipe.Detector1Pipeline.emicorr - INFO - EmiCorrStep instance created.
2025-09-13 16:21:59,955 - stpipe.Detector1Pipeline.saturation - INFO - SaturationStep instance created.
2025-09-13 16:21:59,955 - stpipe.Detector1Pipeline.ipc - INFO - IPCStep instance created.
2025-09-13 16:21:59,956 - stpipe.Detector1Pipeline.superbias - INFO - SuperBiasStep instance created.
2025-09-13 16:21:59,957 - stpipe.Detector1Pipeline.refpix - INFO - RefPixStep instance created.
2025-09-13 16:21:59,958 - stpipe.Detector1Pipeline.rscd - INFO - RscdStep instance created.
2025-09-13 16:21:59,958 - stpipe.Detector1Pipeline.firstframe - INFO - FirstFrameStep instance created.
2025-09-13 16:21:59,959 - stpipe.Detector1Pipeline.lastframe - INFO - LastFrameStep instance created.
2025-09-13 16:21:59,960 - stpipe.Detector1Pipeline.linearity - INFO - LinearityStep instance created.
2025-09-13 16:21:59,961 - stpipe.Detector1Pipeline.dark_current - INFO - DarkCurrentStep instance created.
2025-09-13 16:21:59,961 - stpipe.Detector1Pipeline.reset - INFO - ResetStep instance created.
2025-09-13 16:21:59,962 - stpipe.Detector1Pipeline.persistence - INFO - PersistenceStep instance created.
2025-09-13 16:21:59,963 - stpipe.Detector1Pipeline.charge_migration - INFO - ChargeMigrationStep instance created.
2025-09-13 16:21:59,964 - stpipe.Detector1Pipeline.jump - INFO - JumpStep instance created.
2025-09-13 16:21:59,965 - stpipe.Detector1Pipeline.clean_flicker_noise - INFO - CleanFlickerNoiseStep instance created.
2025-09-13 16:21:59,966 - stpipe.Detector1Pipeline.ramp_fit - INFO - RampFitStep instance created.
2025-09-13 16:21:59,967 - stpipe.Detector1Pipeline.gain_scale - INFO - GainScaleStep instance created.
2025-09-13 16:22:00,150 - stpipe.Detector1Pipeline - INFO - Step Detector1Pipeline running with args ('/home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/uncal/jw02079004003_05101_00003_nis_uncal.fits',).
2025-09-13 16:22:00,170 - stpipe.Detector1Pipeline - INFO - Step Detector1Pipeline parameters are:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage1
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: True
skip: False
suffix: None
search_output_file: True
input_dir: ''
save_calibrated_ramp: False
steps:
group_scale:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
dq_init:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
emicorr:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: True
suffix: None
search_output_file: True
input_dir: ''
algorithm: joint
nints_to_phase: None
nbins: None
scale_reference: True
onthefly_corr_freq: None
use_n_cycles: 3
fit_ints_separately: False
user_supplied_reffile: None
save_intermediate_results: False
saturation:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
n_pix_grow_sat: 1
use_readpatt: True
ipc:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: True
suffix: None
search_output_file: True
input_dir: ''
superbias:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
refpix:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
odd_even_columns: True
use_side_ref_pixels: True
side_smoothing_length: 11
side_gain: 1.0
odd_even_rows: True
ovr_corr_mitigation_ftr: 3.0
preserve_irs2_refpix: False
irs2_mean_subtraction: False
refpix_algorithm: median
sigreject: 4.0
gaussmooth: 1.0
halfwidth: 30
rscd:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
firstframe:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
bright_use_group1: False
lastframe:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
linearity:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
dark_current:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
dark_output: None
average_dark_current: None
reset:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
persistence:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
input_trapsfilled: ''
flag_pers_cutoff: 40.0
save_persistence: False
save_trapsfilled: True
modify_input: False
charge_migration:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
signal_threshold: 22314.0
jump:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
rejection_threshold: 6.0
three_group_rejection_threshold: 6.0
four_group_rejection_threshold: 5.0
maximum_cores: '1'
flag_4_neighbors: False
max_jump_to_flag_neighbors: 200.0
min_jump_to_flag_neighbors: 10.0
after_jump_flag_dn1: 1000
after_jump_flag_time1: 90
after_jump_flag_dn2: 0
after_jump_flag_time2: 0
expand_large_events: True
min_sat_area: 5
min_jump_area: 15.0
expand_factor: 1.75
use_ellipses: False
sat_required_snowball: True
min_sat_radius_extend: 5.0
sat_expand: 0
edge_size: 20
mask_snowball_core_next_int: True
snowball_time_masked_next_int: 4000
find_showers: False
max_shower_amplitude: 4.0
extend_snr_threshold: 1.2
extend_min_area: 90
extend_inner_radius: 1.0
extend_outer_radius: 2.6
extend_ellipse_expand_ratio: 1.1
time_masked_after_shower: 15.0
min_diffs_single_pass: 10
max_extended_radius: 100
minimum_groups: 3
minimum_sigclip_groups: 100
only_use_ints: True
clean_flicker_noise:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: True
suffix: None
search_output_file: True
input_dir: ''
fit_method: median
fit_by_channel: False
background_method: median
background_box_size: None
mask_science_regions: False
apply_flat_field: False
n_sigma: 2.0
fit_histogram: False
single_mask: True
user_mask: None
save_mask: False
save_background: False
save_noise: False
ramp_fit:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
algorithm: OLS_C
int_name: ''
save_opt: False
opt_name: ''
suppress_one_group: True
firstgroup: None
lastgroup: None
maximum_cores: '1'
gain_scale:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
2025-09-13 16:22:00,190 - stpipe.Detector1Pipeline - INFO - Prefetching reference files for dataset: 'jw02079004003_05101_00003_nis_uncal.fits' reftypes = ['dark', 'gain', 'linearity', 'mask', 'persat', 'readnoise', 'refpix', 'reset', 'rscd', 'saturation', 'sirskernel', 'superbias', 'trapdensity', 'trappars']
2025-09-13 16:22:00,193 - stpipe.Detector1Pipeline - INFO - Prefetch for DARK reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_dark_0228.fits'.
2025-09-13 16:22:00,193 - stpipe.Detector1Pipeline - INFO - Prefetch for GAIN reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_gain_0006.fits'.
2025-09-13 16:22:00,194 - stpipe.Detector1Pipeline - INFO - Prefetch for LINEARITY reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_linearity_0017.fits'.
2025-09-13 16:22:00,194 - stpipe.Detector1Pipeline - INFO - Prefetch for MASK reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_mask_0035.fits'.
2025-09-13 16:22:00,194 - stpipe.Detector1Pipeline - INFO - Prefetch for PERSAT reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_persat_0004.fits'.
2025-09-13 16:22:00,195 - stpipe.Detector1Pipeline - INFO - Prefetch for READNOISE reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_readnoise_0005.fits'.
2025-09-13 16:22:00,195 - stpipe.Detector1Pipeline - INFO - Prefetch for REFPIX reference file is 'N/A'.
2025-09-13 16:22:00,195 - stpipe.Detector1Pipeline - INFO - Prefetch for RESET reference file is 'N/A'.
2025-09-13 16:22:00,196 - stpipe.Detector1Pipeline - INFO - Prefetch for RSCD reference file is 'N/A'.
2025-09-13 16:22:00,196 - stpipe.Detector1Pipeline - INFO - Prefetch for SATURATION reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_saturation_0015.fits'.
2025-09-13 16:22:00,196 - stpipe.Detector1Pipeline - INFO - Prefetch for SIRSKERNEL reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_sirskernel_0001.asdf'.
2025-09-13 16:22:00,197 - stpipe.Detector1Pipeline - INFO - Prefetch for SUPERBIAS reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_superbias_0238.fits'.
2025-09-13 16:22:00,197 - stpipe.Detector1Pipeline - INFO - Prefetch for TRAPDENSITY reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_trapdensity_0002.fits'.
2025-09-13 16:22:00,198 - stpipe.Detector1Pipeline - INFO - Prefetch for TRAPPARS reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_trappars_0002.fits'.
2025-09-13 16:22:00,198 - jwst.pipeline.calwebb_detector1 - INFO - Starting calwebb_detector1 ...
2025-09-13 16:22:01,320 - stpipe.Detector1Pipeline.group_scale - INFO - Step group_scale running with args (<RampModel(6, 20, 2048, 2048) from jw02079004003_05101_00003_nis_uncal.fits>,).
2025-09-13 16:22:01,328 - stpipe.Detector1Pipeline.group_scale - INFO - NFRAMES and FRMDIVSR are equal; correction not needed
2025-09-13 16:22:01,329 - stpipe.Detector1Pipeline.group_scale - INFO - Step will be skipped
2025-09-13 16:22:01,330 - stpipe.Detector1Pipeline.group_scale - INFO - Step group_scale done
2025-09-13 16:22:01,510 - stpipe.Detector1Pipeline.dq_init - INFO - Step dq_init running with args (<RampModel(6, 20, 2048, 2048) from jw02079004003_05101_00003_nis_uncal.fits>,).
2025-09-13 16:22:01,519 - stpipe.Detector1Pipeline.dq_init - INFO - Using MASK reference file /home/runner/crds/references/jwst/niriss/jwst_niriss_mask_0035.fits
2025-09-13 16:22:02,438 - stpipe.Detector1Pipeline.dq_init - INFO - Step dq_init done
2025-09-13 16:22:02,622 - stpipe.Detector1Pipeline.saturation - INFO - Step saturation running with args (<RampModel(6, 20, 2048, 2048) from jw02079004003_05101_00003_nis_uncal.fits>,).
2025-09-13 16:22:02,632 - stpipe.Detector1Pipeline.saturation - INFO - Using SATURATION reference file /home/runner/crds/references/jwst/niriss/jwst_niriss_saturation_0015.fits
2025-09-13 16:22:02,633 - stpipe.Detector1Pipeline.saturation - INFO - Using SUPERBIAS reference file /home/runner/crds/references/jwst/niriss/jwst_niriss_superbias_0238.fits
2025-09-13 16:22:02,659 - stdatamodels.dynamicdq - WARNING - Keyword LOWILLUM does not correspond to an existing DQ mnemonic, so will be ignored
2025-09-13 16:22:02,660 - stdatamodels.dynamicdq - WARNING - Keyword LOWRESP does not correspond to an existing DQ mnemonic, so will be ignored
2025-09-13 16:22:02,664 - stdatamodels.dynamicdq - WARNING - Keyword UNCERTAIN does not correspond to an existing DQ mnemonic, so will be ignored
2025-09-13 16:22:03,068 - jwst.saturation.saturation - INFO - Using read_pattern with nframes 4
2025-09-13 16:22:09,167 - stcal.saturation.saturation - INFO - Detected 19603 saturated pixels
2025-09-13 16:22:09,302 - stcal.saturation.saturation - INFO - Detected 6 A/D floor pixels
2025-09-13 16:22:09,308 - stpipe.Detector1Pipeline.saturation - INFO - Step saturation done
2025-09-13 16:22:09,482 - stpipe.Detector1Pipeline.ipc - INFO - Step ipc running with args (<RampModel(6, 20, 2048, 2048) from jw02079004003_05101_00003_nis_uncal.fits>,).
2025-09-13 16:22:09,483 - stpipe.Detector1Pipeline.ipc - INFO - Step skipped.
2025-09-13 16:22:09,647 - stpipe.Detector1Pipeline.superbias - INFO - Step superbias running with args (<RampModel(6, 20, 2048, 2048) from jw02079004003_05101_00003_nis_uncal.fits>,).
2025-09-13 16:22:09,657 - stpipe.Detector1Pipeline.superbias - INFO - Using SUPERBIAS reference file /home/runner/crds/references/jwst/niriss/jwst_niriss_superbias_0238.fits
2025-09-13 16:22:11,257 - stpipe.Detector1Pipeline.superbias - INFO - Step superbias done
2025-09-13 16:22:11,436 - stpipe.Detector1Pipeline.refpix - INFO - Step refpix running with args (<RampModel(6, 20, 2048, 2048) from jw02079004003_05101_00003_nis_uncal.fits>,).
2025-09-13 16:22:11,793 - jwst.refpix.reference_pixels - INFO - NIR full frame data
2025-09-13 16:22:11,793 - jwst.refpix.reference_pixels - INFO - The following parameters are valid for this mode:
2025-09-13 16:22:11,794 - jwst.refpix.reference_pixels - INFO - use_side_ref_pixels = True
2025-09-13 16:22:11,794 - jwst.refpix.reference_pixels - INFO - odd_even_columns = True
2025-09-13 16:22:11,795 - jwst.refpix.reference_pixels - INFO - side_smoothing_length = 11
2025-09-13 16:22:11,795 - jwst.refpix.reference_pixels - INFO - side_gain = 1.0
2025-09-13 16:22:11,795 - jwst.refpix.reference_pixels - INFO - The following parameter is not applicable and is ignored:
2025-09-13 16:22:11,796 - jwst.refpix.reference_pixels - INFO - odd_even_rows = False
2025-09-13 16:22:41,853 - stpipe.Detector1Pipeline.refpix - INFO - Step refpix done
2025-09-13 16:22:42,034 - stpipe.Detector1Pipeline.linearity - INFO - Step linearity running with args (<RampModel(6, 20, 2048, 2048) from jw02079004003_05101_00003_nis_uncal.fits>,).
2025-09-13 16:22:42,043 - stpipe.Detector1Pipeline.linearity - INFO - Using Linearity reference file /home/runner/crds/references/jwst/niriss/jwst_niriss_linearity_0017.fits
2025-09-13 16:22:42,087 - stdatamodels.dynamicdq - WARNING - Keyword LOWILLUM does not correspond to an existing DQ mnemonic, so will be ignored
2025-09-13 16:22:42,088 - stdatamodels.dynamicdq - WARNING - Keyword LOWRESP does not correspond to an existing DQ mnemonic, so will be ignored
2025-09-13 16:22:42,092 - stdatamodels.dynamicdq - WARNING - Keyword UNCERTAIN does not correspond to an existing DQ mnemonic, so will be ignored
2025-09-13 16:22:46,213 - stpipe.Detector1Pipeline.linearity - INFO - Step linearity done
2025-09-13 16:22:46,392 - stpipe.Detector1Pipeline.persistence - INFO - Step persistence running with args (<RampModel(6, 20, 2048, 2048) from jw02079004003_05101_00003_nis_uncal.fits>,).
2025-09-13 16:23:07,901 - stpipe.Detector1Pipeline.persistence - INFO - Saved model in /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage1/jw02079004003_05101_00003_nis_trapsfilled.fits
2025-09-13 16:23:07,904 - stpipe.Detector1Pipeline.persistence - INFO - Step persistence done
2025-09-13 16:23:08,083 - stpipe.Detector1Pipeline.dark_current - INFO - Step dark_current running with args (<RampModel(6, 20, 2048, 2048) from jw02079004003_05101_00003_nis_uncal.fits>,).
2025-09-13 16:23:08,092 - stpipe.Detector1Pipeline.dark_current - INFO - Using DARK reference file /home/runner/crds/references/jwst/niriss/jwst_niriss_dark_0228.fits
2025-09-13 16:23:08,620 - stcal.dark_current.dark_sub - INFO - Science data nints=6, ngroups=20, nframes=4, groupgap=0
2025-09-13 16:23:08,621 - stcal.dark_current.dark_sub - INFO - Dark data nints=1, ngroups=30, nframes=4, groupgap=0
2025-09-13 16:23:09,485 - stpipe.Detector1Pipeline.dark_current - INFO - Step dark_current done
2025-09-13 16:23:09,671 - stpipe.Detector1Pipeline.charge_migration - INFO - Step charge_migration running with args (<RampModel(6, 20, 2048, 2048) from jw02079004003_05101_00003_nis_uncal.fits>,).
2025-09-13 16:23:10,035 - jwst.charge_migration.charge_migration - INFO - Using signal_threshold: 22314.00
2025-09-13 16:23:13,402 - stpipe.Detector1Pipeline.charge_migration - INFO - Step charge_migration done
2025-09-13 16:23:13,573 - stpipe.Detector1Pipeline.jump - INFO - Step jump running with args (<RampModel(6, 20, 2048, 2048) from jw02079004003_05101_00003_nis_uncal.fits>,).
2025-09-13 16:23:13,580 - stpipe.Detector1Pipeline.jump - INFO - CR rejection threshold = 6 sigma
2025-09-13 16:23:13,581 - stpipe.Detector1Pipeline.jump - INFO - Maximum cores to use = 1
2025-09-13 16:23:13,947 - stpipe.Detector1Pipeline.jump - INFO - Using GAIN reference file: /home/runner/crds/references/jwst/niriss/jwst_niriss_gain_0006.fits
2025-09-13 16:23:13,950 - stpipe.Detector1Pipeline.jump - INFO - Using READNOISE reference file: /home/runner/crds/references/jwst/niriss/jwst_niriss_readnoise_0005.fits
2025-09-13 16:23:14,630 - stcal.jump.jump - INFO - Executing two-point difference method
2025-09-13 16:23:42,530 - stcal.jump.jump - INFO - Flagging Snowballs
2025-09-13 16:23:44,900 - stcal.jump.jump - INFO - Total snowballs = 704
2025-09-13 16:23:44,901 - stcal.jump.jump - INFO - Total elapsed time = 30.2704 sec
2025-09-13 16:23:45,403 - stpipe.Detector1Pipeline.jump - INFO - The execution time in seconds: 31.822072
2025-09-13 16:23:45,405 - stpipe.Detector1Pipeline.jump - INFO - Step jump done
2025-09-13 16:23:45,582 - stpipe.Detector1Pipeline.clean_flicker_noise - INFO - Step clean_flicker_noise running with args (<RampModel(6, 20, 2048, 2048) from jw02079004003_05101_00003_nis_uncal.fits>,).
2025-09-13 16:23:45,583 - stpipe.Detector1Pipeline.clean_flicker_noise - INFO - Step skipped.
2025-09-13 16:23:45,748 - stpipe.Detector1Pipeline.ramp_fit - INFO - Step ramp_fit running with args (<RampModel(6, 20, 2048, 2048) from jw02079004003_05101_00003_nis_uncal.fits>,).
2025-09-13 16:23:46,104 - jwst.ramp_fitting.ramp_fit_step - INFO - Using READNOISE reference file: /home/runner/crds/references/jwst/niriss/jwst_niriss_readnoise_0005.fits
2025-09-13 16:23:46,105 - jwst.ramp_fitting.ramp_fit_step - INFO - Using GAIN reference file: /home/runner/crds/references/jwst/niriss/jwst_niriss_gain_0006.fits
2025-09-13 16:23:46,130 - jwst.ramp_fitting.ramp_fit_step - INFO - Using algorithm = OLS_C
2025-09-13 16:23:46,131 - jwst.ramp_fitting.ramp_fit_step - INFO - Using weighting = optimal
2025-09-13 16:23:47,715 - stcal.ramp_fitting.ols_fit - INFO - Number of multiprocessing slices: 1
2025-09-13 16:24:27,791 - stcal.ramp_fitting.ols_fit - INFO - Ramp Fitting C Time: 40.06969499588013
2025-09-13 16:24:27,840 - stpipe.Detector1Pipeline.ramp_fit - INFO - Step ramp_fit done
2025-09-13 16:24:28,024 - stpipe.Detector1Pipeline.gain_scale - INFO - Step gain_scale running with args (<ImageModel(2048, 2048) from jw02079004003_05101_00003_nis_uncal.fits>,).
2025-09-13 16:24:28,044 - stpipe.Detector1Pipeline.gain_scale - INFO - GAINFACT not found in gain reference file
2025-09-13 16:24:28,045 - stpipe.Detector1Pipeline.gain_scale - INFO - Step will be skipped
2025-09-13 16:24:28,046 - stpipe.Detector1Pipeline.gain_scale - INFO - Step gain_scale done
2025-09-13 16:24:28,221 - stpipe.Detector1Pipeline.gain_scale - INFO - Step gain_scale running with args (<CubeModel(6, 2048, 2048) from jw02079004003_05101_00003_nis_uncal.fits>,).
2025-09-13 16:24:28,240 - stpipe.Detector1Pipeline.gain_scale - INFO - GAINFACT not found in gain reference file
2025-09-13 16:24:28,241 - stpipe.Detector1Pipeline.gain_scale - INFO - Step will be skipped
2025-09-13 16:24:28,243 - stpipe.Detector1Pipeline.gain_scale - INFO - Step gain_scale done
2025-09-13 16:24:28,672 - stpipe.Detector1Pipeline - INFO - Saved model in /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage1/jw02079004003_05101_00003_nis_rateints.fits
2025-09-13 16:24:28,673 - jwst.pipeline.calwebb_detector1 - INFO - ... ending calwebb_detector1
2025-09-13 16:24:28,676 - jwst.stpipe.core - INFO - Results used CRDS context: jwst_1413.pmap
2025-09-13 16:24:28,784 - stpipe.Detector1Pipeline - INFO - Saved model in /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage1/jw02079004003_05101_00003_nis_rate.fits
2025-09-13 16:24:28,784 - stpipe.Detector1Pipeline - INFO - Step Detector1Pipeline done
2025-09-13 16:24:28,785 - jwst.stpipe.core - INFO - Results used jwst version: 1.19.1
2025-09-13 16:24:28,815 - CRDS - ERROR - Error determining best reference for 'pars-darkcurrentstep' = No match found.
2025-09-13 16:24:28,819 - stpipe - INFO - PARS-CHARGEMIGRATIONSTEP parameters found: /home/runner/crds/references/jwst/niriss/jwst_niriss_pars-chargemigrationstep_0016.asdf
2025-09-13 16:24:28,827 - stpipe - INFO - PARS-JUMPSTEP parameters found: /home/runner/crds/references/jwst/niriss/jwst_niriss_pars-jumpstep_0085.asdf
2025-09-13 16:24:28,837 - stpipe - INFO - PARS-DETECTOR1PIPELINE parameters found: /home/runner/crds/references/jwst/niriss/jwst_niriss_pars-detector1pipeline_0001.asdf
2025-09-13 16:24:28,852 - stpipe.Detector1Pipeline - INFO - Detector1Pipeline instance created.
2025-09-13 16:24:28,853 - stpipe.Detector1Pipeline.group_scale - INFO - GroupScaleStep instance created.
2025-09-13 16:24:28,854 - stpipe.Detector1Pipeline.dq_init - INFO - DQInitStep instance created.
2025-09-13 16:24:28,855 - stpipe.Detector1Pipeline.emicorr - INFO - EmiCorrStep instance created.
2025-09-13 16:24:28,856 - stpipe.Detector1Pipeline.saturation - INFO - SaturationStep instance created.
2025-09-13 16:24:28,856 - stpipe.Detector1Pipeline.ipc - INFO - IPCStep instance created.
2025-09-13 16:24:28,857 - stpipe.Detector1Pipeline.superbias - INFO - SuperBiasStep instance created.
2025-09-13 16:24:28,858 - stpipe.Detector1Pipeline.refpix - INFO - RefPixStep instance created.
2025-09-13 16:24:28,859 - stpipe.Detector1Pipeline.rscd - INFO - RscdStep instance created.
2025-09-13 16:24:28,859 - stpipe.Detector1Pipeline.firstframe - INFO - FirstFrameStep instance created.
2025-09-13 16:24:28,860 - stpipe.Detector1Pipeline.lastframe - INFO - LastFrameStep instance created.
2025-09-13 16:24:28,861 - stpipe.Detector1Pipeline.linearity - INFO - LinearityStep instance created.
2025-09-13 16:24:28,862 - stpipe.Detector1Pipeline.dark_current - INFO - DarkCurrentStep instance created.
2025-09-13 16:24:28,862 - stpipe.Detector1Pipeline.reset - INFO - ResetStep instance created.
2025-09-13 16:24:28,863 - stpipe.Detector1Pipeline.persistence - INFO - PersistenceStep instance created.
2025-09-13 16:24:28,864 - stpipe.Detector1Pipeline.charge_migration - INFO - ChargeMigrationStep instance created.
2025-09-13 16:24:28,865 - stpipe.Detector1Pipeline.jump - INFO - JumpStep instance created.
2025-09-13 16:24:28,866 - stpipe.Detector1Pipeline.clean_flicker_noise - INFO - CleanFlickerNoiseStep instance created.
2025-09-13 16:24:28,867 - stpipe.Detector1Pipeline.ramp_fit - INFO - RampFitStep instance created.
2025-09-13 16:24:28,868 - stpipe.Detector1Pipeline.gain_scale - INFO - GainScaleStep instance created.
2025-09-13 16:24:29,041 - stpipe.Detector1Pipeline - INFO - Step Detector1Pipeline running with args ('/home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/uncal/jw02079004003_06101_00001_nis_uncal.fits',).
2025-09-13 16:24:29,061 - stpipe.Detector1Pipeline - INFO - Step Detector1Pipeline parameters are:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage1
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: True
skip: False
suffix: None
search_output_file: True
input_dir: ''
save_calibrated_ramp: False
steps:
group_scale:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
dq_init:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
emicorr:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: True
suffix: None
search_output_file: True
input_dir: ''
algorithm: joint
nints_to_phase: None
nbins: None
scale_reference: True
onthefly_corr_freq: None
use_n_cycles: 3
fit_ints_separately: False
user_supplied_reffile: None
save_intermediate_results: False
saturation:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
n_pix_grow_sat: 1
use_readpatt: True
ipc:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: True
suffix: None
search_output_file: True
input_dir: ''
superbias:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
refpix:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
odd_even_columns: True
use_side_ref_pixels: True
side_smoothing_length: 11
side_gain: 1.0
odd_even_rows: True
ovr_corr_mitigation_ftr: 3.0
preserve_irs2_refpix: False
irs2_mean_subtraction: False
refpix_algorithm: median
sigreject: 4.0
gaussmooth: 1.0
halfwidth: 30
rscd:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
firstframe:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
bright_use_group1: False
lastframe:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
linearity:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
dark_current:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
dark_output: None
average_dark_current: None
reset:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
persistence:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
input_trapsfilled: ''
flag_pers_cutoff: 40.0
save_persistence: False
save_trapsfilled: True
modify_input: False
charge_migration:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
signal_threshold: 22314.0
jump:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
rejection_threshold: 4.0
three_group_rejection_threshold: 6.0
four_group_rejection_threshold: 5.0
maximum_cores: '1'
flag_4_neighbors: False
max_jump_to_flag_neighbors: 200.0
min_jump_to_flag_neighbors: 10.0
after_jump_flag_dn1: 1000
after_jump_flag_time1: 90
after_jump_flag_dn2: 0
after_jump_flag_time2: 0
expand_large_events: True
min_sat_area: 5
min_jump_area: 15.0
expand_factor: 1.75
use_ellipses: False
sat_required_snowball: True
min_sat_radius_extend: 5.0
sat_expand: 0
edge_size: 20
mask_snowball_core_next_int: True
snowball_time_masked_next_int: 4000
find_showers: False
max_shower_amplitude: 4.0
extend_snr_threshold: 1.2
extend_min_area: 90
extend_inner_radius: 1.0
extend_outer_radius: 2.6
extend_ellipse_expand_ratio: 1.1
time_masked_after_shower: 15.0
min_diffs_single_pass: 10
max_extended_radius: 100
minimum_groups: 3
minimum_sigclip_groups: 100
only_use_ints: True
clean_flicker_noise:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: True
suffix: None
search_output_file: True
input_dir: ''
fit_method: median
fit_by_channel: False
background_method: median
background_box_size: None
mask_science_regions: False
apply_flat_field: False
n_sigma: 2.0
fit_histogram: False
single_mask: True
user_mask: None
save_mask: False
save_background: False
save_noise: False
ramp_fit:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
algorithm: OLS_C
int_name: ''
save_opt: False
opt_name: ''
suppress_one_group: True
firstgroup: None
lastgroup: None
maximum_cores: '1'
gain_scale:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
2025-09-13 16:24:29,081 - stpipe.Detector1Pipeline - INFO - Prefetching reference files for dataset: 'jw02079004003_06101_00001_nis_uncal.fits' reftypes = ['dark', 'gain', 'linearity', 'mask', 'persat', 'readnoise', 'refpix', 'reset', 'rscd', 'saturation', 'sirskernel', 'superbias', 'trapdensity', 'trappars']
2025-09-13 16:24:29,084 - stpipe.Detector1Pipeline - INFO - Prefetch for DARK reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_dark_0228.fits'.
2025-09-13 16:24:29,084 - stpipe.Detector1Pipeline - INFO - Prefetch for GAIN reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_gain_0006.fits'.
2025-09-13 16:24:29,085 - stpipe.Detector1Pipeline - INFO - Prefetch for LINEARITY reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_linearity_0017.fits'.
2025-09-13 16:24:29,085 - stpipe.Detector1Pipeline - INFO - Prefetch for MASK reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_mask_0035.fits'.
2025-09-13 16:24:29,086 - stpipe.Detector1Pipeline - INFO - Prefetch for PERSAT reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_persat_0004.fits'.
2025-09-13 16:24:29,086 - stpipe.Detector1Pipeline - INFO - Prefetch for READNOISE reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_readnoise_0005.fits'.
2025-09-13 16:24:29,086 - stpipe.Detector1Pipeline - INFO - Prefetch for REFPIX reference file is 'N/A'.
2025-09-13 16:24:29,087 - stpipe.Detector1Pipeline - INFO - Prefetch for RESET reference file is 'N/A'.
2025-09-13 16:24:29,087 - stpipe.Detector1Pipeline - INFO - Prefetch for RSCD reference file is 'N/A'.
2025-09-13 16:24:29,087 - stpipe.Detector1Pipeline - INFO - Prefetch for SATURATION reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_saturation_0015.fits'.
2025-09-13 16:24:29,088 - stpipe.Detector1Pipeline - INFO - Prefetch for SIRSKERNEL reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_sirskernel_0001.asdf'.
2025-09-13 16:24:29,088 - stpipe.Detector1Pipeline - INFO - Prefetch for SUPERBIAS reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_superbias_0238.fits'.
2025-09-13 16:24:29,088 - stpipe.Detector1Pipeline - INFO - Prefetch for TRAPDENSITY reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_trapdensity_0002.fits'.
2025-09-13 16:24:29,089 - stpipe.Detector1Pipeline - INFO - Prefetch for TRAPPARS reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_trappars_0002.fits'.
2025-09-13 16:24:29,089 - jwst.pipeline.calwebb_detector1 - INFO - Starting calwebb_detector1 ...
2025-09-13 16:24:29,376 - stpipe.Detector1Pipeline.group_scale - INFO - Step group_scale running with args (<RampModel(1, 5, 2048, 2048) from jw02079004003_06101_00001_nis_uncal.fits>,).
2025-09-13 16:24:29,383 - stpipe.Detector1Pipeline.group_scale - INFO - NFRAMES and FRMDIVSR are equal; correction not needed
2025-09-13 16:24:29,384 - stpipe.Detector1Pipeline.group_scale - INFO - Step will be skipped
2025-09-13 16:24:29,385 - stpipe.Detector1Pipeline.group_scale - INFO - Step group_scale done
2025-09-13 16:24:29,557 - stpipe.Detector1Pipeline.dq_init - INFO - Step dq_init running with args (<RampModel(1, 5, 2048, 2048) from jw02079004003_06101_00001_nis_uncal.fits>,).
2025-09-13 16:24:29,566 - stpipe.Detector1Pipeline.dq_init - INFO - Using MASK reference file /home/runner/crds/references/jwst/niriss/jwst_niriss_mask_0035.fits
2025-09-13 16:24:29,715 - stpipe.Detector1Pipeline.dq_init - INFO - Step dq_init done
2025-09-13 16:24:29,889 - stpipe.Detector1Pipeline.saturation - INFO - Step saturation running with args (<RampModel(1, 5, 2048, 2048) from jw02079004003_06101_00001_nis_uncal.fits>,).
2025-09-13 16:24:29,900 - stpipe.Detector1Pipeline.saturation - INFO - Using SATURATION reference file /home/runner/crds/references/jwst/niriss/jwst_niriss_saturation_0015.fits
2025-09-13 16:24:29,900 - stpipe.Detector1Pipeline.saturation - INFO - Using SUPERBIAS reference file /home/runner/crds/references/jwst/niriss/jwst_niriss_superbias_0238.fits
2025-09-13 16:24:29,926 - stdatamodels.dynamicdq - WARNING - Keyword LOWILLUM does not correspond to an existing DQ mnemonic, so will be ignored
2025-09-13 16:24:29,927 - stdatamodels.dynamicdq - WARNING - Keyword LOWRESP does not correspond to an existing DQ mnemonic, so will be ignored
2025-09-13 16:24:29,931 - stdatamodels.dynamicdq - WARNING - Keyword UNCERTAIN does not correspond to an existing DQ mnemonic, so will be ignored
2025-09-13 16:24:29,989 - jwst.saturation.saturation - INFO - Using read_pattern with nframes 4
2025-09-13 16:24:30,365 - stcal.saturation.saturation - INFO - Detected 821 saturated pixels
2025-09-13 16:24:30,374 - stcal.saturation.saturation - INFO - Detected 1 A/D floor pixels
2025-09-13 16:24:30,380 - stpipe.Detector1Pipeline.saturation - INFO - Step saturation done
2025-09-13 16:24:30,562 - stpipe.Detector1Pipeline.ipc - INFO - Step ipc running with args (<RampModel(1, 5, 2048, 2048) from jw02079004003_06101_00001_nis_uncal.fits>,).
2025-09-13 16:24:30,562 - stpipe.Detector1Pipeline.ipc - INFO - Step skipped.
2025-09-13 16:24:30,739 - stpipe.Detector1Pipeline.superbias - INFO - Step superbias running with args (<RampModel(1, 5, 2048, 2048) from jw02079004003_06101_00001_nis_uncal.fits>,).
2025-09-13 16:24:30,749 - stpipe.Detector1Pipeline.superbias - INFO - Using SUPERBIAS reference file /home/runner/crds/references/jwst/niriss/jwst_niriss_superbias_0238.fits
2025-09-13 16:24:30,884 - stpipe.Detector1Pipeline.superbias - INFO - Step superbias done
2025-09-13 16:24:31,063 - stpipe.Detector1Pipeline.refpix - INFO - Step refpix running with args (<RampModel(1, 5, 2048, 2048) from jw02079004003_06101_00001_nis_uncal.fits>,).
2025-09-13 16:24:31,088 - jwst.refpix.reference_pixels - INFO - NIR full frame data
2025-09-13 16:24:31,088 - jwst.refpix.reference_pixels - INFO - The following parameters are valid for this mode:
2025-09-13 16:24:31,089 - jwst.refpix.reference_pixels - INFO - use_side_ref_pixels = True
2025-09-13 16:24:31,089 - jwst.refpix.reference_pixels - INFO - odd_even_columns = True
2025-09-13 16:24:31,090 - jwst.refpix.reference_pixels - INFO - side_smoothing_length = 11
2025-09-13 16:24:31,090 - jwst.refpix.reference_pixels - INFO - side_gain = 1.0
2025-09-13 16:24:31,090 - jwst.refpix.reference_pixels - INFO - The following parameter is not applicable and is ignored:
2025-09-13 16:24:31,090 - jwst.refpix.reference_pixels - INFO - odd_even_rows = False
2025-09-13 16:24:32,359 - stpipe.Detector1Pipeline.refpix - INFO - Step refpix done
2025-09-13 16:24:32,527 - stpipe.Detector1Pipeline.linearity - INFO - Step linearity running with args (<RampModel(1, 5, 2048, 2048) from jw02079004003_06101_00001_nis_uncal.fits>,).
2025-09-13 16:24:32,537 - stpipe.Detector1Pipeline.linearity - INFO - Using Linearity reference file /home/runner/crds/references/jwst/niriss/jwst_niriss_linearity_0017.fits
2025-09-13 16:24:32,588 - stdatamodels.dynamicdq - WARNING - Keyword LOWILLUM does not correspond to an existing DQ mnemonic, so will be ignored
2025-09-13 16:24:32,588 - stdatamodels.dynamicdq - WARNING - Keyword LOWRESP does not correspond to an existing DQ mnemonic, so will be ignored
2025-09-13 16:24:32,593 - stdatamodels.dynamicdq - WARNING - Keyword UNCERTAIN does not correspond to an existing DQ mnemonic, so will be ignored
2025-09-13 16:24:32,899 - stpipe.Detector1Pipeline.linearity - INFO - Step linearity done
2025-09-13 16:24:33,072 - stpipe.Detector1Pipeline.persistence - INFO - Step persistence running with args (<RampModel(1, 5, 2048, 2048) from jw02079004003_06101_00001_nis_uncal.fits>,).
2025-09-13 16:24:34,378 - stpipe.Detector1Pipeline.persistence - INFO - Saved model in /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage1/jw02079004003_06101_00001_nis_trapsfilled.fits
2025-09-13 16:24:34,382 - stpipe.Detector1Pipeline.persistence - INFO - Step persistence done
2025-09-13 16:24:34,562 - stpipe.Detector1Pipeline.dark_current - INFO - Step dark_current running with args (<RampModel(1, 5, 2048, 2048) from jw02079004003_06101_00001_nis_uncal.fits>,).
2025-09-13 16:24:34,571 - stpipe.Detector1Pipeline.dark_current - INFO - Using DARK reference file /home/runner/crds/references/jwst/niriss/jwst_niriss_dark_0228.fits
2025-09-13 16:24:34,790 - stcal.dark_current.dark_sub - INFO - Science data nints=1, ngroups=5, nframes=4, groupgap=0
2025-09-13 16:24:34,790 - stcal.dark_current.dark_sub - INFO - Dark data nints=1, ngroups=30, nframes=4, groupgap=0
2025-09-13 16:24:34,935 - stpipe.Detector1Pipeline.dark_current - INFO - Step dark_current done
2025-09-13 16:24:35,118 - stpipe.Detector1Pipeline.charge_migration - INFO - Step charge_migration running with args (<RampModel(1, 5, 2048, 2048) from jw02079004003_06101_00001_nis_uncal.fits>,).
2025-09-13 16:24:35,142 - jwst.charge_migration.charge_migration - INFO - Using signal_threshold: 22314.00
2025-09-13 16:24:35,219 - stpipe.Detector1Pipeline.charge_migration - INFO - Step charge_migration done
2025-09-13 16:24:35,393 - stpipe.Detector1Pipeline.jump - INFO - Step jump running with args (<RampModel(1, 5, 2048, 2048) from jw02079004003_06101_00001_nis_uncal.fits>,).
2025-09-13 16:24:35,401 - stpipe.Detector1Pipeline.jump - INFO - CR rejection threshold = 4 sigma
2025-09-13 16:24:35,401 - stpipe.Detector1Pipeline.jump - INFO - Maximum cores to use = 1
2025-09-13 16:24:35,438 - stpipe.Detector1Pipeline.jump - INFO - Using GAIN reference file: /home/runner/crds/references/jwst/niriss/jwst_niriss_gain_0006.fits
2025-09-13 16:24:35,440 - stpipe.Detector1Pipeline.jump - INFO - Using READNOISE reference file: /home/runner/crds/references/jwst/niriss/jwst_niriss_readnoise_0005.fits
2025-09-13 16:24:35,553 - stcal.jump.jump - INFO - Executing two-point difference method
2025-09-13 16:24:38,701 - stcal.jump.jump - INFO - Flagging Snowballs
2025-09-13 16:24:38,839 - stcal.jump.jump - INFO - Total snowballs = 17
2025-09-13 16:24:38,840 - stcal.jump.jump - INFO - Total elapsed time = 3.28579 sec
2025-09-13 16:24:38,867 - stpipe.Detector1Pipeline.jump - INFO - The execution time in seconds: 3.466378
2025-09-13 16:24:38,870 - stpipe.Detector1Pipeline.jump - INFO - Step jump done
2025-09-13 16:24:39,053 - stpipe.Detector1Pipeline.clean_flicker_noise - INFO - Step clean_flicker_noise running with args (<RampModel(1, 5, 2048, 2048) from jw02079004003_06101_00001_nis_uncal.fits>,).
2025-09-13 16:24:39,054 - stpipe.Detector1Pipeline.clean_flicker_noise - INFO - Step skipped.
2025-09-13 16:24:39,231 - stpipe.Detector1Pipeline.ramp_fit - INFO - Step ramp_fit running with args (<RampModel(1, 5, 2048, 2048) from jw02079004003_06101_00001_nis_uncal.fits>,).
2025-09-13 16:24:39,260 - jwst.ramp_fitting.ramp_fit_step - INFO - Using READNOISE reference file: /home/runner/crds/references/jwst/niriss/jwst_niriss_readnoise_0005.fits
2025-09-13 16:24:39,260 - jwst.ramp_fitting.ramp_fit_step - INFO - Using GAIN reference file: /home/runner/crds/references/jwst/niriss/jwst_niriss_gain_0006.fits
2025-09-13 16:24:39,287 - jwst.ramp_fitting.ramp_fit_step - INFO - Using algorithm = OLS_C
2025-09-13 16:24:39,287 - jwst.ramp_fitting.ramp_fit_step - INFO - Using weighting = optimal
2025-09-13 16:24:39,388 - stcal.ramp_fitting.ols_fit - INFO - Number of multiprocessing slices: 1
2025-09-13 16:24:41,218 - stcal.ramp_fitting.ols_fit - INFO - Ramp Fitting C Time: 1.8259572982788086
2025-09-13 16:24:41,260 - stpipe.Detector1Pipeline.ramp_fit - INFO - Step ramp_fit done
2025-09-13 16:24:41,432 - stpipe.Detector1Pipeline.gain_scale - INFO - Step gain_scale running with args (<ImageModel(2048, 2048) from jw02079004003_06101_00001_nis_uncal.fits>,).
2025-09-13 16:24:41,452 - stpipe.Detector1Pipeline.gain_scale - INFO - GAINFACT not found in gain reference file
2025-09-13 16:24:41,452 - stpipe.Detector1Pipeline.gain_scale - INFO - Step will be skipped
2025-09-13 16:24:41,454 - stpipe.Detector1Pipeline.gain_scale - INFO - Step gain_scale done
2025-09-13 16:24:41,623 - stpipe.Detector1Pipeline.gain_scale - INFO - Step gain_scale running with args (<CubeModel(1, 2048, 2048) from jw02079004003_06101_00001_nis_uncal.fits>,).
2025-09-13 16:24:41,644 - stpipe.Detector1Pipeline.gain_scale - INFO - GAINFACT not found in gain reference file
2025-09-13 16:24:41,645 - stpipe.Detector1Pipeline.gain_scale - INFO - Step will be skipped
2025-09-13 16:24:41,647 - stpipe.Detector1Pipeline.gain_scale - INFO - Step gain_scale done
2025-09-13 16:24:41,759 - stpipe.Detector1Pipeline - INFO - Saved model in /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage1/jw02079004003_06101_00001_nis_rateints.fits
2025-09-13 16:24:41,760 - jwst.pipeline.calwebb_detector1 - INFO - ... ending calwebb_detector1
2025-09-13 16:24:41,761 - jwst.stpipe.core - INFO - Results used CRDS context: jwst_1413.pmap
2025-09-13 16:24:41,871 - stpipe.Detector1Pipeline - INFO - Saved model in /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage1/jw02079004003_06101_00001_nis_rate.fits
2025-09-13 16:24:41,871 - stpipe.Detector1Pipeline - INFO - Step Detector1Pipeline done
2025-09-13 16:24:41,872 - jwst.stpipe.core - INFO - Results used jwst version: 1.19.1
2025-09-13 16:24:41,901 - CRDS - ERROR - Error determining best reference for 'pars-darkcurrentstep' = No match found.
2025-09-13 16:24:41,904 - stpipe - INFO - PARS-CHARGEMIGRATIONSTEP parameters found: /home/runner/crds/references/jwst/niriss/jwst_niriss_pars-chargemigrationstep_0016.asdf
2025-09-13 16:24:41,912 - stpipe - INFO - PARS-JUMPSTEP parameters found: /home/runner/crds/references/jwst/niriss/jwst_niriss_pars-jumpstep_0085.asdf
2025-09-13 16:24:41,923 - stpipe - INFO - PARS-DETECTOR1PIPELINE parameters found: /home/runner/crds/references/jwst/niriss/jwst_niriss_pars-detector1pipeline_0001.asdf
2025-09-13 16:24:41,938 - stpipe.Detector1Pipeline - INFO - Detector1Pipeline instance created.
2025-09-13 16:24:41,939 - stpipe.Detector1Pipeline.group_scale - INFO - GroupScaleStep instance created.
2025-09-13 16:24:41,940 - stpipe.Detector1Pipeline.dq_init - INFO - DQInitStep instance created.
2025-09-13 16:24:41,941 - stpipe.Detector1Pipeline.emicorr - INFO - EmiCorrStep instance created.
2025-09-13 16:24:41,942 - stpipe.Detector1Pipeline.saturation - INFO - SaturationStep instance created.
2025-09-13 16:24:41,942 - stpipe.Detector1Pipeline.ipc - INFO - IPCStep instance created.
2025-09-13 16:24:41,943 - stpipe.Detector1Pipeline.superbias - INFO - SuperBiasStep instance created.
2025-09-13 16:24:41,944 - stpipe.Detector1Pipeline.refpix - INFO - RefPixStep instance created.
2025-09-13 16:24:41,945 - stpipe.Detector1Pipeline.rscd - INFO - RscdStep instance created.
2025-09-13 16:24:41,945 - stpipe.Detector1Pipeline.firstframe - INFO - FirstFrameStep instance created.
2025-09-13 16:24:41,946 - stpipe.Detector1Pipeline.lastframe - INFO - LastFrameStep instance created.
2025-09-13 16:24:41,947 - stpipe.Detector1Pipeline.linearity - INFO - LinearityStep instance created.
2025-09-13 16:24:41,947 - stpipe.Detector1Pipeline.dark_current - INFO - DarkCurrentStep instance created.
2025-09-13 16:24:41,948 - stpipe.Detector1Pipeline.reset - INFO - ResetStep instance created.
2025-09-13 16:24:41,949 - stpipe.Detector1Pipeline.persistence - INFO - PersistenceStep instance created.
2025-09-13 16:24:41,950 - stpipe.Detector1Pipeline.charge_migration - INFO - ChargeMigrationStep instance created.
2025-09-13 16:24:41,951 - stpipe.Detector1Pipeline.jump - INFO - JumpStep instance created.
2025-09-13 16:24:41,953 - stpipe.Detector1Pipeline.clean_flicker_noise - INFO - CleanFlickerNoiseStep instance created.
2025-09-13 16:24:41,954 - stpipe.Detector1Pipeline.ramp_fit - INFO - RampFitStep instance created.
2025-09-13 16:24:41,955 - stpipe.Detector1Pipeline.gain_scale - INFO - GainScaleStep instance created.
2025-09-13 16:24:42,126 - stpipe.Detector1Pipeline - INFO - Step Detector1Pipeline running with args ('/home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/uncal/jw02079004003_06101_00002_nis_uncal.fits',).
2025-09-13 16:24:42,146 - stpipe.Detector1Pipeline - INFO - Step Detector1Pipeline parameters are:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage1
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: True
skip: False
suffix: None
search_output_file: True
input_dir: ''
save_calibrated_ramp: False
steps:
group_scale:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
dq_init:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
emicorr:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: True
suffix: None
search_output_file: True
input_dir: ''
algorithm: joint
nints_to_phase: None
nbins: None
scale_reference: True
onthefly_corr_freq: None
use_n_cycles: 3
fit_ints_separately: False
user_supplied_reffile: None
save_intermediate_results: False
saturation:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
n_pix_grow_sat: 1
use_readpatt: True
ipc:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: True
suffix: None
search_output_file: True
input_dir: ''
superbias:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
refpix:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
odd_even_columns: True
use_side_ref_pixels: True
side_smoothing_length: 11
side_gain: 1.0
odd_even_rows: True
ovr_corr_mitigation_ftr: 3.0
preserve_irs2_refpix: False
irs2_mean_subtraction: False
refpix_algorithm: median
sigreject: 4.0
gaussmooth: 1.0
halfwidth: 30
rscd:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
firstframe:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
bright_use_group1: False
lastframe:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
linearity:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
dark_current:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
dark_output: None
average_dark_current: None
reset:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
persistence:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
input_trapsfilled: ''
flag_pers_cutoff: 40.0
save_persistence: False
save_trapsfilled: True
modify_input: False
charge_migration:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
signal_threshold: 22314.0
jump:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
rejection_threshold: 4.0
three_group_rejection_threshold: 6.0
four_group_rejection_threshold: 5.0
maximum_cores: '1'
flag_4_neighbors: False
max_jump_to_flag_neighbors: 200.0
min_jump_to_flag_neighbors: 10.0
after_jump_flag_dn1: 1000
after_jump_flag_time1: 90
after_jump_flag_dn2: 0
after_jump_flag_time2: 0
expand_large_events: True
min_sat_area: 5
min_jump_area: 15.0
expand_factor: 1.75
use_ellipses: False
sat_required_snowball: True
min_sat_radius_extend: 5.0
sat_expand: 0
edge_size: 20
mask_snowball_core_next_int: True
snowball_time_masked_next_int: 4000
find_showers: False
max_shower_amplitude: 4.0
extend_snr_threshold: 1.2
extend_min_area: 90
extend_inner_radius: 1.0
extend_outer_radius: 2.6
extend_ellipse_expand_ratio: 1.1
time_masked_after_shower: 15.0
min_diffs_single_pass: 10
max_extended_radius: 100
minimum_groups: 3
minimum_sigclip_groups: 100
only_use_ints: True
clean_flicker_noise:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: True
suffix: None
search_output_file: True
input_dir: ''
fit_method: median
fit_by_channel: False
background_method: median
background_box_size: None
mask_science_regions: False
apply_flat_field: False
n_sigma: 2.0
fit_histogram: False
single_mask: True
user_mask: None
save_mask: False
save_background: False
save_noise: False
ramp_fit:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
algorithm: OLS_C
int_name: ''
save_opt: False
opt_name: ''
suppress_one_group: True
firstgroup: None
lastgroup: None
maximum_cores: '1'
gain_scale:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
2025-09-13 16:24:42,166 - stpipe.Detector1Pipeline - INFO - Prefetching reference files for dataset: 'jw02079004003_06101_00002_nis_uncal.fits' reftypes = ['dark', 'gain', 'linearity', 'mask', 'persat', 'readnoise', 'refpix', 'reset', 'rscd', 'saturation', 'sirskernel', 'superbias', 'trapdensity', 'trappars']
2025-09-13 16:24:42,169 - stpipe.Detector1Pipeline - INFO - Prefetch for DARK reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_dark_0228.fits'.
2025-09-13 16:24:42,169 - stpipe.Detector1Pipeline - INFO - Prefetch for GAIN reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_gain_0006.fits'.
2025-09-13 16:24:42,170 - stpipe.Detector1Pipeline - INFO - Prefetch for LINEARITY reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_linearity_0017.fits'.
2025-09-13 16:24:42,170 - stpipe.Detector1Pipeline - INFO - Prefetch for MASK reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_mask_0035.fits'.
2025-09-13 16:24:42,170 - stpipe.Detector1Pipeline - INFO - Prefetch for PERSAT reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_persat_0004.fits'.
2025-09-13 16:24:42,171 - stpipe.Detector1Pipeline - INFO - Prefetch for READNOISE reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_readnoise_0005.fits'.
2025-09-13 16:24:42,171 - stpipe.Detector1Pipeline - INFO - Prefetch for REFPIX reference file is 'N/A'.
2025-09-13 16:24:42,171 - stpipe.Detector1Pipeline - INFO - Prefetch for RESET reference file is 'N/A'.
2025-09-13 16:24:42,171 - stpipe.Detector1Pipeline - INFO - Prefetch for RSCD reference file is 'N/A'.
2025-09-13 16:24:42,172 - stpipe.Detector1Pipeline - INFO - Prefetch for SATURATION reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_saturation_0015.fits'.
2025-09-13 16:24:42,172 - stpipe.Detector1Pipeline - INFO - Prefetch for SIRSKERNEL reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_sirskernel_0001.asdf'.
2025-09-13 16:24:42,172 - stpipe.Detector1Pipeline - INFO - Prefetch for SUPERBIAS reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_superbias_0238.fits'.
2025-09-13 16:24:42,173 - stpipe.Detector1Pipeline - INFO - Prefetch for TRAPDENSITY reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_trapdensity_0002.fits'.
2025-09-13 16:24:42,173 - stpipe.Detector1Pipeline - INFO - Prefetch for TRAPPARS reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_trappars_0002.fits'.
2025-09-13 16:24:42,173 - jwst.pipeline.calwebb_detector1 - INFO - Starting calwebb_detector1 ...
2025-09-13 16:24:42,459 - stpipe.Detector1Pipeline.group_scale - INFO - Step group_scale running with args (<RampModel(1, 5, 2048, 2048) from jw02079004003_06101_00002_nis_uncal.fits>,).
2025-09-13 16:24:42,467 - stpipe.Detector1Pipeline.group_scale - INFO - NFRAMES and FRMDIVSR are equal; correction not needed
2025-09-13 16:24:42,467 - stpipe.Detector1Pipeline.group_scale - INFO - Step will be skipped
2025-09-13 16:24:42,468 - stpipe.Detector1Pipeline.group_scale - INFO - Step group_scale done
2025-09-13 16:24:42,640 - stpipe.Detector1Pipeline.dq_init - INFO - Step dq_init running with args (<RampModel(1, 5, 2048, 2048) from jw02079004003_06101_00002_nis_uncal.fits>,).
2025-09-13 16:24:42,649 - stpipe.Detector1Pipeline.dq_init - INFO - Using MASK reference file /home/runner/crds/references/jwst/niriss/jwst_niriss_mask_0035.fits
2025-09-13 16:24:42,785 - stpipe.Detector1Pipeline.dq_init - INFO - Step dq_init done
2025-09-13 16:24:42,958 - stpipe.Detector1Pipeline.saturation - INFO - Step saturation running with args (<RampModel(1, 5, 2048, 2048) from jw02079004003_06101_00002_nis_uncal.fits>,).
2025-09-13 16:24:42,968 - stpipe.Detector1Pipeline.saturation - INFO - Using SATURATION reference file /home/runner/crds/references/jwst/niriss/jwst_niriss_saturation_0015.fits
2025-09-13 16:24:42,969 - stpipe.Detector1Pipeline.saturation - INFO - Using SUPERBIAS reference file /home/runner/crds/references/jwst/niriss/jwst_niriss_superbias_0238.fits
2025-09-13 16:24:42,995 - stdatamodels.dynamicdq - WARNING - Keyword LOWILLUM does not correspond to an existing DQ mnemonic, so will be ignored
2025-09-13 16:24:42,996 - stdatamodels.dynamicdq - WARNING - Keyword LOWRESP does not correspond to an existing DQ mnemonic, so will be ignored
2025-09-13 16:24:43,000 - stdatamodels.dynamicdq - WARNING - Keyword UNCERTAIN does not correspond to an existing DQ mnemonic, so will be ignored
2025-09-13 16:24:43,066 - jwst.saturation.saturation - INFO - Using read_pattern with nframes 4
2025-09-13 16:24:43,432 - stcal.saturation.saturation - INFO - Detected 859 saturated pixels
2025-09-13 16:24:43,441 - stcal.saturation.saturation - INFO - Detected 1 A/D floor pixels
2025-09-13 16:24:43,448 - stpipe.Detector1Pipeline.saturation - INFO - Step saturation done
2025-09-13 16:24:43,625 - stpipe.Detector1Pipeline.ipc - INFO - Step ipc running with args (<RampModel(1, 5, 2048, 2048) from jw02079004003_06101_00002_nis_uncal.fits>,).
2025-09-13 16:24:43,626 - stpipe.Detector1Pipeline.ipc - INFO - Step skipped.
2025-09-13 16:24:43,798 - stpipe.Detector1Pipeline.superbias - INFO - Step superbias running with args (<RampModel(1, 5, 2048, 2048) from jw02079004003_06101_00002_nis_uncal.fits>,).
2025-09-13 16:24:43,807 - stpipe.Detector1Pipeline.superbias - INFO - Using SUPERBIAS reference file /home/runner/crds/references/jwst/niriss/jwst_niriss_superbias_0238.fits
2025-09-13 16:24:43,936 - stpipe.Detector1Pipeline.superbias - INFO - Step superbias done
2025-09-13 16:24:44,115 - stpipe.Detector1Pipeline.refpix - INFO - Step refpix running with args (<RampModel(1, 5, 2048, 2048) from jw02079004003_06101_00002_nis_uncal.fits>,).
2025-09-13 16:24:44,158 - jwst.refpix.reference_pixels - INFO - NIR full frame data
2025-09-13 16:24:44,159 - jwst.refpix.reference_pixels - INFO - The following parameters are valid for this mode:
2025-09-13 16:24:44,159 - jwst.refpix.reference_pixels - INFO - use_side_ref_pixels = True
2025-09-13 16:24:44,159 - jwst.refpix.reference_pixels - INFO - odd_even_columns = True
2025-09-13 16:24:44,160 - jwst.refpix.reference_pixels - INFO - side_smoothing_length = 11
2025-09-13 16:24:44,160 - jwst.refpix.reference_pixels - INFO - side_gain = 1.0
2025-09-13 16:24:44,160 - jwst.refpix.reference_pixels - INFO - The following parameter is not applicable and is ignored:
2025-09-13 16:24:44,160 - jwst.refpix.reference_pixels - INFO - odd_even_rows = False
2025-09-13 16:24:45,447 - stpipe.Detector1Pipeline.refpix - INFO - Step refpix done
2025-09-13 16:24:45,624 - stpipe.Detector1Pipeline.linearity - INFO - Step linearity running with args (<RampModel(1, 5, 2048, 2048) from jw02079004003_06101_00002_nis_uncal.fits>,).
2025-09-13 16:24:45,633 - stpipe.Detector1Pipeline.linearity - INFO - Using Linearity reference file /home/runner/crds/references/jwst/niriss/jwst_niriss_linearity_0017.fits
2025-09-13 16:24:45,678 - stdatamodels.dynamicdq - WARNING - Keyword LOWILLUM does not correspond to an existing DQ mnemonic, so will be ignored
2025-09-13 16:24:45,679 - stdatamodels.dynamicdq - WARNING - Keyword LOWRESP does not correspond to an existing DQ mnemonic, so will be ignored
2025-09-13 16:24:45,683 - stdatamodels.dynamicdq - WARNING - Keyword UNCERTAIN does not correspond to an existing DQ mnemonic, so will be ignored
2025-09-13 16:24:45,984 - stpipe.Detector1Pipeline.linearity - INFO - Step linearity done
2025-09-13 16:24:46,163 - stpipe.Detector1Pipeline.persistence - INFO - Step persistence running with args (<RampModel(1, 5, 2048, 2048) from jw02079004003_06101_00002_nis_uncal.fits>,).
2025-09-13 16:24:47,495 - stpipe.Detector1Pipeline.persistence - INFO - Saved model in /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage1/jw02079004003_06101_00002_nis_trapsfilled.fits
2025-09-13 16:24:47,498 - stpipe.Detector1Pipeline.persistence - INFO - Step persistence done
2025-09-13 16:24:47,673 - stpipe.Detector1Pipeline.dark_current - INFO - Step dark_current running with args (<RampModel(1, 5, 2048, 2048) from jw02079004003_06101_00002_nis_uncal.fits>,).
2025-09-13 16:24:47,683 - stpipe.Detector1Pipeline.dark_current - INFO - Using DARK reference file /home/runner/crds/references/jwst/niriss/jwst_niriss_dark_0228.fits
2025-09-13 16:24:47,886 - stcal.dark_current.dark_sub - INFO - Science data nints=1, ngroups=5, nframes=4, groupgap=0
2025-09-13 16:24:47,887 - stcal.dark_current.dark_sub - INFO - Dark data nints=1, ngroups=30, nframes=4, groupgap=0
2025-09-13 16:24:48,045 - stpipe.Detector1Pipeline.dark_current - INFO - Step dark_current done
2025-09-13 16:24:48,222 - stpipe.Detector1Pipeline.charge_migration - INFO - Step charge_migration running with args (<RampModel(1, 5, 2048, 2048) from jw02079004003_06101_00002_nis_uncal.fits>,).
2025-09-13 16:24:48,257 - jwst.charge_migration.charge_migration - INFO - Using signal_threshold: 22314.00
2025-09-13 16:24:48,338 - stpipe.Detector1Pipeline.charge_migration - INFO - Step charge_migration done
2025-09-13 16:24:48,512 - stpipe.Detector1Pipeline.jump - INFO - Step jump running with args (<RampModel(1, 5, 2048, 2048) from jw02079004003_06101_00002_nis_uncal.fits>,).
2025-09-13 16:24:48,520 - stpipe.Detector1Pipeline.jump - INFO - CR rejection threshold = 4 sigma
2025-09-13 16:24:48,521 - stpipe.Detector1Pipeline.jump - INFO - Maximum cores to use = 1
2025-09-13 16:24:48,540 - stpipe.Detector1Pipeline.jump - INFO - Using GAIN reference file: /home/runner/crds/references/jwst/niriss/jwst_niriss_gain_0006.fits
2025-09-13 16:24:48,543 - stpipe.Detector1Pipeline.jump - INFO - Using READNOISE reference file: /home/runner/crds/references/jwst/niriss/jwst_niriss_readnoise_0005.fits
2025-09-13 16:24:48,659 - stcal.jump.jump - INFO - Executing two-point difference method
2025-09-13 16:24:51,804 - stcal.jump.jump - INFO - Flagging Snowballs
2025-09-13 16:24:51,946 - stcal.jump.jump - INFO - Total snowballs = 19
2025-09-13 16:24:51,947 - stcal.jump.jump - INFO - Total elapsed time = 3.28753 sec
2025-09-13 16:24:51,974 - stpipe.Detector1Pipeline.jump - INFO - The execution time in seconds: 3.453800
2025-09-13 16:24:51,977 - stpipe.Detector1Pipeline.jump - INFO - Step jump done
2025-09-13 16:24:52,158 - stpipe.Detector1Pipeline.clean_flicker_noise - INFO - Step clean_flicker_noise running with args (<RampModel(1, 5, 2048, 2048) from jw02079004003_06101_00002_nis_uncal.fits>,).
2025-09-13 16:24:52,159 - stpipe.Detector1Pipeline.clean_flicker_noise - INFO - Step skipped.
2025-09-13 16:24:52,333 - stpipe.Detector1Pipeline.ramp_fit - INFO - Step ramp_fit running with args (<RampModel(1, 5, 2048, 2048) from jw02079004003_06101_00002_nis_uncal.fits>,).
2025-09-13 16:24:52,361 - jwst.ramp_fitting.ramp_fit_step - INFO - Using READNOISE reference file: /home/runner/crds/references/jwst/niriss/jwst_niriss_readnoise_0005.fits
2025-09-13 16:24:52,362 - jwst.ramp_fitting.ramp_fit_step - INFO - Using GAIN reference file: /home/runner/crds/references/jwst/niriss/jwst_niriss_gain_0006.fits
2025-09-13 16:24:52,388 - jwst.ramp_fitting.ramp_fit_step - INFO - Using algorithm = OLS_C
2025-09-13 16:24:52,389 - jwst.ramp_fitting.ramp_fit_step - INFO - Using weighting = optimal
2025-09-13 16:24:52,500 - stcal.ramp_fitting.ols_fit - INFO - Number of multiprocessing slices: 1
2025-09-13 16:24:54,320 - stcal.ramp_fitting.ols_fit - INFO - Ramp Fitting C Time: 1.816056251525879
2025-09-13 16:24:54,361 - stpipe.Detector1Pipeline.ramp_fit - INFO - Step ramp_fit done
2025-09-13 16:24:54,534 - stpipe.Detector1Pipeline.gain_scale - INFO - Step gain_scale running with args (<ImageModel(2048, 2048) from jw02079004003_06101_00002_nis_uncal.fits>,).
2025-09-13 16:24:54,554 - stpipe.Detector1Pipeline.gain_scale - INFO - GAINFACT not found in gain reference file
2025-09-13 16:24:54,554 - stpipe.Detector1Pipeline.gain_scale - INFO - Step will be skipped
2025-09-13 16:24:54,556 - stpipe.Detector1Pipeline.gain_scale - INFO - Step gain_scale done
2025-09-13 16:24:54,723 - stpipe.Detector1Pipeline.gain_scale - INFO - Step gain_scale running with args (<CubeModel(1, 2048, 2048) from jw02079004003_06101_00002_nis_uncal.fits>,).
2025-09-13 16:24:54,744 - stpipe.Detector1Pipeline.gain_scale - INFO - GAINFACT not found in gain reference file
2025-09-13 16:24:54,745 - stpipe.Detector1Pipeline.gain_scale - INFO - Step will be skipped
2025-09-13 16:24:54,746 - stpipe.Detector1Pipeline.gain_scale - INFO - Step gain_scale done
2025-09-13 16:24:54,858 - stpipe.Detector1Pipeline - INFO - Saved model in /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage1/jw02079004003_06101_00002_nis_rateints.fits
2025-09-13 16:24:54,859 - jwst.pipeline.calwebb_detector1 - INFO - ... ending calwebb_detector1
2025-09-13 16:24:54,861 - jwst.stpipe.core - INFO - Results used CRDS context: jwst_1413.pmap
2025-09-13 16:24:54,972 - stpipe.Detector1Pipeline - INFO - Saved model in /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage1/jw02079004003_06101_00002_nis_rate.fits
2025-09-13 16:24:54,973 - stpipe.Detector1Pipeline - INFO - Step Detector1Pipeline done
2025-09-13 16:24:54,973 - jwst.stpipe.core - INFO - Results used jwst version: 1.19.1
2025-09-13 16:24:55,003 - CRDS - ERROR - Error determining best reference for 'pars-darkcurrentstep' = No match found.
2025-09-13 16:24:55,006 - stpipe - INFO - PARS-CHARGEMIGRATIONSTEP parameters found: /home/runner/crds/references/jwst/niriss/jwst_niriss_pars-chargemigrationstep_0016.asdf
2025-09-13 16:24:55,014 - stpipe - INFO - PARS-JUMPSTEP parameters found: /home/runner/crds/references/jwst/niriss/jwst_niriss_pars-jumpstep_0085.asdf
2025-09-13 16:24:55,024 - stpipe - INFO - PARS-DETECTOR1PIPELINE parameters found: /home/runner/crds/references/jwst/niriss/jwst_niriss_pars-detector1pipeline_0001.asdf
2025-09-13 16:24:55,039 - stpipe.Detector1Pipeline - INFO - Detector1Pipeline instance created.
2025-09-13 16:24:55,040 - stpipe.Detector1Pipeline.group_scale - INFO - GroupScaleStep instance created.
2025-09-13 16:24:55,041 - stpipe.Detector1Pipeline.dq_init - INFO - DQInitStep instance created.
2025-09-13 16:24:55,042 - stpipe.Detector1Pipeline.emicorr - INFO - EmiCorrStep instance created.
2025-09-13 16:24:55,043 - stpipe.Detector1Pipeline.saturation - INFO - SaturationStep instance created.
2025-09-13 16:24:55,044 - stpipe.Detector1Pipeline.ipc - INFO - IPCStep instance created.
2025-09-13 16:24:55,044 - stpipe.Detector1Pipeline.superbias - INFO - SuperBiasStep instance created.
2025-09-13 16:24:55,045 - stpipe.Detector1Pipeline.refpix - INFO - RefPixStep instance created.
2025-09-13 16:24:55,046 - stpipe.Detector1Pipeline.rscd - INFO - RscdStep instance created.
2025-09-13 16:24:55,047 - stpipe.Detector1Pipeline.firstframe - INFO - FirstFrameStep instance created.
2025-09-13 16:24:55,047 - stpipe.Detector1Pipeline.lastframe - INFO - LastFrameStep instance created.
2025-09-13 16:24:55,048 - stpipe.Detector1Pipeline.linearity - INFO - LinearityStep instance created.
2025-09-13 16:24:55,049 - stpipe.Detector1Pipeline.dark_current - INFO - DarkCurrentStep instance created.
2025-09-13 16:24:55,049 - stpipe.Detector1Pipeline.reset - INFO - ResetStep instance created.
2025-09-13 16:24:55,050 - stpipe.Detector1Pipeline.persistence - INFO - PersistenceStep instance created.
2025-09-13 16:24:55,051 - stpipe.Detector1Pipeline.charge_migration - INFO - ChargeMigrationStep instance created.
2025-09-13 16:24:55,053 - stpipe.Detector1Pipeline.jump - INFO - JumpStep instance created.
2025-09-13 16:24:55,054 - stpipe.Detector1Pipeline.clean_flicker_noise - INFO - CleanFlickerNoiseStep instance created.
2025-09-13 16:24:55,054 - stpipe.Detector1Pipeline.ramp_fit - INFO - RampFitStep instance created.
2025-09-13 16:24:55,055 - stpipe.Detector1Pipeline.gain_scale - INFO - GainScaleStep instance created.
2025-09-13 16:24:55,234 - stpipe.Detector1Pipeline - INFO - Step Detector1Pipeline running with args ('/home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/uncal/jw02079004003_06101_00003_nis_uncal.fits',).
2025-09-13 16:24:55,256 - stpipe.Detector1Pipeline - INFO - Step Detector1Pipeline parameters are:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage1
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: True
skip: False
suffix: None
search_output_file: True
input_dir: ''
save_calibrated_ramp: False
steps:
group_scale:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
dq_init:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
emicorr:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: True
suffix: None
search_output_file: True
input_dir: ''
algorithm: joint
nints_to_phase: None
nbins: None
scale_reference: True
onthefly_corr_freq: None
use_n_cycles: 3
fit_ints_separately: False
user_supplied_reffile: None
save_intermediate_results: False
saturation:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
n_pix_grow_sat: 1
use_readpatt: True
ipc:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: True
suffix: None
search_output_file: True
input_dir: ''
superbias:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
refpix:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
odd_even_columns: True
use_side_ref_pixels: True
side_smoothing_length: 11
side_gain: 1.0
odd_even_rows: True
ovr_corr_mitigation_ftr: 3.0
preserve_irs2_refpix: False
irs2_mean_subtraction: False
refpix_algorithm: median
sigreject: 4.0
gaussmooth: 1.0
halfwidth: 30
rscd:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
firstframe:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
bright_use_group1: False
lastframe:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
linearity:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
dark_current:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
dark_output: None
average_dark_current: None
reset:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
persistence:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
input_trapsfilled: ''
flag_pers_cutoff: 40.0
save_persistence: False
save_trapsfilled: True
modify_input: False
charge_migration:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
signal_threshold: 22314.0
jump:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
rejection_threshold: 4.0
three_group_rejection_threshold: 6.0
four_group_rejection_threshold: 5.0
maximum_cores: '1'
flag_4_neighbors: False
max_jump_to_flag_neighbors: 200.0
min_jump_to_flag_neighbors: 10.0
after_jump_flag_dn1: 1000
after_jump_flag_time1: 90
after_jump_flag_dn2: 0
after_jump_flag_time2: 0
expand_large_events: True
min_sat_area: 5
min_jump_area: 15.0
expand_factor: 1.75
use_ellipses: False
sat_required_snowball: True
min_sat_radius_extend: 5.0
sat_expand: 0
edge_size: 20
mask_snowball_core_next_int: True
snowball_time_masked_next_int: 4000
find_showers: False
max_shower_amplitude: 4.0
extend_snr_threshold: 1.2
extend_min_area: 90
extend_inner_radius: 1.0
extend_outer_radius: 2.6
extend_ellipse_expand_ratio: 1.1
time_masked_after_shower: 15.0
min_diffs_single_pass: 10
max_extended_radius: 100
minimum_groups: 3
minimum_sigclip_groups: 100
only_use_ints: True
clean_flicker_noise:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: True
suffix: None
search_output_file: True
input_dir: ''
fit_method: median
fit_by_channel: False
background_method: median
background_box_size: None
mask_science_regions: False
apply_flat_field: False
n_sigma: 2.0
fit_histogram: False
single_mask: True
user_mask: None
save_mask: False
save_background: False
save_noise: False
ramp_fit:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
algorithm: OLS_C
int_name: ''
save_opt: False
opt_name: ''
suppress_one_group: True
firstgroup: None
lastgroup: None
maximum_cores: '1'
gain_scale:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
2025-09-13 16:24:55,276 - stpipe.Detector1Pipeline - INFO - Prefetching reference files for dataset: 'jw02079004003_06101_00003_nis_uncal.fits' reftypes = ['dark', 'gain', 'linearity', 'mask', 'persat', 'readnoise', 'refpix', 'reset', 'rscd', 'saturation', 'sirskernel', 'superbias', 'trapdensity', 'trappars']
2025-09-13 16:24:55,279 - stpipe.Detector1Pipeline - INFO - Prefetch for DARK reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_dark_0228.fits'.
2025-09-13 16:24:55,279 - stpipe.Detector1Pipeline - INFO - Prefetch for GAIN reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_gain_0006.fits'.
2025-09-13 16:24:55,280 - stpipe.Detector1Pipeline - INFO - Prefetch for LINEARITY reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_linearity_0017.fits'.
2025-09-13 16:24:55,280 - stpipe.Detector1Pipeline - INFO - Prefetch for MASK reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_mask_0035.fits'.
2025-09-13 16:24:55,281 - stpipe.Detector1Pipeline - INFO - Prefetch for PERSAT reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_persat_0004.fits'.
2025-09-13 16:24:55,281 - stpipe.Detector1Pipeline - INFO - Prefetch for READNOISE reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_readnoise_0005.fits'.
2025-09-13 16:24:55,281 - stpipe.Detector1Pipeline - INFO - Prefetch for REFPIX reference file is 'N/A'.
2025-09-13 16:24:55,282 - stpipe.Detector1Pipeline - INFO - Prefetch for RESET reference file is 'N/A'.
2025-09-13 16:24:55,282 - stpipe.Detector1Pipeline - INFO - Prefetch for RSCD reference file is 'N/A'.
2025-09-13 16:24:55,282 - stpipe.Detector1Pipeline - INFO - Prefetch for SATURATION reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_saturation_0015.fits'.
2025-09-13 16:24:55,283 - stpipe.Detector1Pipeline - INFO - Prefetch for SIRSKERNEL reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_sirskernel_0001.asdf'.
2025-09-13 16:24:55,283 - stpipe.Detector1Pipeline - INFO - Prefetch for SUPERBIAS reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_superbias_0238.fits'.
2025-09-13 16:24:55,283 - stpipe.Detector1Pipeline - INFO - Prefetch for TRAPDENSITY reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_trapdensity_0002.fits'.
2025-09-13 16:24:55,284 - stpipe.Detector1Pipeline - INFO - Prefetch for TRAPPARS reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_trappars_0002.fits'.
2025-09-13 16:24:55,284 - jwst.pipeline.calwebb_detector1 - INFO - Starting calwebb_detector1 ...
2025-09-13 16:24:55,573 - stpipe.Detector1Pipeline.group_scale - INFO - Step group_scale running with args (<RampModel(1, 5, 2048, 2048) from jw02079004003_06101_00003_nis_uncal.fits>,).
2025-09-13 16:24:55,580 - stpipe.Detector1Pipeline.group_scale - INFO - NFRAMES and FRMDIVSR are equal; correction not needed
2025-09-13 16:24:55,580 - stpipe.Detector1Pipeline.group_scale - INFO - Step will be skipped
2025-09-13 16:24:55,582 - stpipe.Detector1Pipeline.group_scale - INFO - Step group_scale done
2025-09-13 16:24:55,754 - stpipe.Detector1Pipeline.dq_init - INFO - Step dq_init running with args (<RampModel(1, 5, 2048, 2048) from jw02079004003_06101_00003_nis_uncal.fits>,).
2025-09-13 16:24:55,763 - stpipe.Detector1Pipeline.dq_init - INFO - Using MASK reference file /home/runner/crds/references/jwst/niriss/jwst_niriss_mask_0035.fits
2025-09-13 16:24:55,890 - stpipe.Detector1Pipeline.dq_init - INFO - Step dq_init done
2025-09-13 16:24:56,064 - stpipe.Detector1Pipeline.saturation - INFO - Step saturation running with args (<RampModel(1, 5, 2048, 2048) from jw02079004003_06101_00003_nis_uncal.fits>,).
2025-09-13 16:24:56,074 - stpipe.Detector1Pipeline.saturation - INFO - Using SATURATION reference file /home/runner/crds/references/jwst/niriss/jwst_niriss_saturation_0015.fits
2025-09-13 16:24:56,075 - stpipe.Detector1Pipeline.saturation - INFO - Using SUPERBIAS reference file /home/runner/crds/references/jwst/niriss/jwst_niriss_superbias_0238.fits
2025-09-13 16:24:56,101 - stdatamodels.dynamicdq - WARNING - Keyword LOWILLUM does not correspond to an existing DQ mnemonic, so will be ignored
2025-09-13 16:24:56,102 - stdatamodels.dynamicdq - WARNING - Keyword LOWRESP does not correspond to an existing DQ mnemonic, so will be ignored
2025-09-13 16:24:56,106 - stdatamodels.dynamicdq - WARNING - Keyword UNCERTAIN does not correspond to an existing DQ mnemonic, so will be ignored
2025-09-13 16:24:56,163 - jwst.saturation.saturation - INFO - Using read_pattern with nframes 4
2025-09-13 16:24:56,524 - stcal.saturation.saturation - INFO - Detected 931 saturated pixels
2025-09-13 16:24:56,533 - stcal.saturation.saturation - INFO - Detected 1 A/D floor pixels
2025-09-13 16:24:56,539 - stpipe.Detector1Pipeline.saturation - INFO - Step saturation done
2025-09-13 16:24:56,713 - stpipe.Detector1Pipeline.ipc - INFO - Step ipc running with args (<RampModel(1, 5, 2048, 2048) from jw02079004003_06101_00003_nis_uncal.fits>,).
2025-09-13 16:24:56,714 - stpipe.Detector1Pipeline.ipc - INFO - Step skipped.
2025-09-13 16:24:56,888 - stpipe.Detector1Pipeline.superbias - INFO - Step superbias running with args (<RampModel(1, 5, 2048, 2048) from jw02079004003_06101_00003_nis_uncal.fits>,).
2025-09-13 16:24:56,897 - stpipe.Detector1Pipeline.superbias - INFO - Using SUPERBIAS reference file /home/runner/crds/references/jwst/niriss/jwst_niriss_superbias_0238.fits
2025-09-13 16:24:57,015 - stpipe.Detector1Pipeline.superbias - INFO - Step superbias done
2025-09-13 16:24:57,187 - stpipe.Detector1Pipeline.refpix - INFO - Step refpix running with args (<RampModel(1, 5, 2048, 2048) from jw02079004003_06101_00003_nis_uncal.fits>,).
2025-09-13 16:24:57,223 - jwst.refpix.reference_pixels - INFO - NIR full frame data
2025-09-13 16:24:57,224 - jwst.refpix.reference_pixels - INFO - The following parameters are valid for this mode:
2025-09-13 16:24:57,224 - jwst.refpix.reference_pixels - INFO - use_side_ref_pixels = True
2025-09-13 16:24:57,225 - jwst.refpix.reference_pixels - INFO - odd_even_columns = True
2025-09-13 16:24:57,225 - jwst.refpix.reference_pixels - INFO - side_smoothing_length = 11
2025-09-13 16:24:57,225 - jwst.refpix.reference_pixels - INFO - side_gain = 1.0
2025-09-13 16:24:57,226 - jwst.refpix.reference_pixels - INFO - The following parameter is not applicable and is ignored:
2025-09-13 16:24:57,226 - jwst.refpix.reference_pixels - INFO - odd_even_rows = False
2025-09-13 16:24:58,488 - stpipe.Detector1Pipeline.refpix - INFO - Step refpix done
2025-09-13 16:24:58,670 - stpipe.Detector1Pipeline.linearity - INFO - Step linearity running with args (<RampModel(1, 5, 2048, 2048) from jw02079004003_06101_00003_nis_uncal.fits>,).
2025-09-13 16:24:58,679 - stpipe.Detector1Pipeline.linearity - INFO - Using Linearity reference file /home/runner/crds/references/jwst/niriss/jwst_niriss_linearity_0017.fits
2025-09-13 16:24:58,725 - stdatamodels.dynamicdq - WARNING - Keyword LOWILLUM does not correspond to an existing DQ mnemonic, so will be ignored
2025-09-13 16:24:58,725 - stdatamodels.dynamicdq - WARNING - Keyword LOWRESP does not correspond to an existing DQ mnemonic, so will be ignored
2025-09-13 16:24:58,730 - stdatamodels.dynamicdq - WARNING - Keyword UNCERTAIN does not correspond to an existing DQ mnemonic, so will be ignored
2025-09-13 16:24:59,030 - stpipe.Detector1Pipeline.linearity - INFO - Step linearity done
2025-09-13 16:24:59,211 - stpipe.Detector1Pipeline.persistence - INFO - Step persistence running with args (<RampModel(1, 5, 2048, 2048) from jw02079004003_06101_00003_nis_uncal.fits>,).
2025-09-13 16:25:00,527 - stpipe.Detector1Pipeline.persistence - INFO - Saved model in /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage1/jw02079004003_06101_00003_nis_trapsfilled.fits
2025-09-13 16:25:00,530 - stpipe.Detector1Pipeline.persistence - INFO - Step persistence done
2025-09-13 16:25:00,709 - stpipe.Detector1Pipeline.dark_current - INFO - Step dark_current running with args (<RampModel(1, 5, 2048, 2048) from jw02079004003_06101_00003_nis_uncal.fits>,).
2025-09-13 16:25:00,718 - stpipe.Detector1Pipeline.dark_current - INFO - Using DARK reference file /home/runner/crds/references/jwst/niriss/jwst_niriss_dark_0228.fits
2025-09-13 16:25:00,923 - stcal.dark_current.dark_sub - INFO - Science data nints=1, ngroups=5, nframes=4, groupgap=0
2025-09-13 16:25:00,924 - stcal.dark_current.dark_sub - INFO - Dark data nints=1, ngroups=30, nframes=4, groupgap=0
2025-09-13 16:25:01,079 - stpipe.Detector1Pipeline.dark_current - INFO - Step dark_current done
2025-09-13 16:25:01,257 - stpipe.Detector1Pipeline.charge_migration - INFO - Step charge_migration running with args (<RampModel(1, 5, 2048, 2048) from jw02079004003_06101_00003_nis_uncal.fits>,).
2025-09-13 16:25:01,294 - jwst.charge_migration.charge_migration - INFO - Using signal_threshold: 22314.00
2025-09-13 16:25:01,373 - stpipe.Detector1Pipeline.charge_migration - INFO - Step charge_migration done
2025-09-13 16:25:01,547 - stpipe.Detector1Pipeline.jump - INFO - Step jump running with args (<RampModel(1, 5, 2048, 2048) from jw02079004003_06101_00003_nis_uncal.fits>,).
2025-09-13 16:25:01,555 - stpipe.Detector1Pipeline.jump - INFO - CR rejection threshold = 4 sigma
2025-09-13 16:25:01,555 - stpipe.Detector1Pipeline.jump - INFO - Maximum cores to use = 1
2025-09-13 16:25:01,574 - stpipe.Detector1Pipeline.jump - INFO - Using GAIN reference file: /home/runner/crds/references/jwst/niriss/jwst_niriss_gain_0006.fits
2025-09-13 16:25:01,577 - stpipe.Detector1Pipeline.jump - INFO - Using READNOISE reference file: /home/runner/crds/references/jwst/niriss/jwst_niriss_readnoise_0005.fits
2025-09-13 16:25:01,691 - stcal.jump.jump - INFO - Executing two-point difference method
2025-09-13 16:25:04,810 - stcal.jump.jump - INFO - Flagging Snowballs
2025-09-13 16:25:04,969 - stcal.jump.jump - INFO - Total snowballs = 22
2025-09-13 16:25:04,970 - stcal.jump.jump - INFO - Total elapsed time = 3.27826 sec
2025-09-13 16:25:04,996 - stpipe.Detector1Pipeline.jump - INFO - The execution time in seconds: 3.441305
2025-09-13 16:25:04,999 - stpipe.Detector1Pipeline.jump - INFO - Step jump done
2025-09-13 16:25:05,178 - stpipe.Detector1Pipeline.clean_flicker_noise - INFO - Step clean_flicker_noise running with args (<RampModel(1, 5, 2048, 2048) from jw02079004003_06101_00003_nis_uncal.fits>,).
2025-09-13 16:25:05,179 - stpipe.Detector1Pipeline.clean_flicker_noise - INFO - Step skipped.
2025-09-13 16:25:05,355 - stpipe.Detector1Pipeline.ramp_fit - INFO - Step ramp_fit running with args (<RampModel(1, 5, 2048, 2048) from jw02079004003_06101_00003_nis_uncal.fits>,).
2025-09-13 16:25:05,383 - jwst.ramp_fitting.ramp_fit_step - INFO - Using READNOISE reference file: /home/runner/crds/references/jwst/niriss/jwst_niriss_readnoise_0005.fits
2025-09-13 16:25:05,384 - jwst.ramp_fitting.ramp_fit_step - INFO - Using GAIN reference file: /home/runner/crds/references/jwst/niriss/jwst_niriss_gain_0006.fits
2025-09-13 16:25:05,409 - jwst.ramp_fitting.ramp_fit_step - INFO - Using algorithm = OLS_C
2025-09-13 16:25:05,410 - jwst.ramp_fitting.ramp_fit_step - INFO - Using weighting = optimal
2025-09-13 16:25:05,508 - stcal.ramp_fitting.ols_fit - INFO - Number of multiprocessing slices: 1
2025-09-13 16:25:07,297 - stcal.ramp_fitting.ols_fit - INFO - Ramp Fitting C Time: 1.7847545146942139
2025-09-13 16:25:07,339 - stpipe.Detector1Pipeline.ramp_fit - INFO - Step ramp_fit done
2025-09-13 16:25:07,524 - stpipe.Detector1Pipeline.gain_scale - INFO - Step gain_scale running with args (<ImageModel(2048, 2048) from jw02079004003_06101_00003_nis_uncal.fits>,).
2025-09-13 16:25:07,544 - stpipe.Detector1Pipeline.gain_scale - INFO - GAINFACT not found in gain reference file
2025-09-13 16:25:07,545 - stpipe.Detector1Pipeline.gain_scale - INFO - Step will be skipped
2025-09-13 16:25:07,547 - stpipe.Detector1Pipeline.gain_scale - INFO - Step gain_scale done
2025-09-13 16:25:07,729 - stpipe.Detector1Pipeline.gain_scale - INFO - Step gain_scale running with args (<CubeModel(1, 2048, 2048) from jw02079004003_06101_00003_nis_uncal.fits>,).
2025-09-13 16:25:07,750 - stpipe.Detector1Pipeline.gain_scale - INFO - GAINFACT not found in gain reference file
2025-09-13 16:25:07,751 - stpipe.Detector1Pipeline.gain_scale - INFO - Step will be skipped
2025-09-13 16:25:07,752 - stpipe.Detector1Pipeline.gain_scale - INFO - Step gain_scale done
2025-09-13 16:25:07,865 - stpipe.Detector1Pipeline - INFO - Saved model in /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage1/jw02079004003_06101_00003_nis_rateints.fits
2025-09-13 16:25:07,865 - jwst.pipeline.calwebb_detector1 - INFO - ... ending calwebb_detector1
2025-09-13 16:25:07,867 - jwst.stpipe.core - INFO - Results used CRDS context: jwst_1413.pmap
2025-09-13 16:25:07,980 - stpipe.Detector1Pipeline - INFO - Saved model in /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage1/jw02079004003_06101_00003_nis_rate.fits
2025-09-13 16:25:07,981 - stpipe.Detector1Pipeline - INFO - Step Detector1Pipeline done
2025-09-13 16:25:07,981 - jwst.stpipe.core - INFO - Results used jwst version: 1.19.1
Inspect Detector1 Output Products#
In the Detector1 stage, both the direct images (EXP_TYPE=NIS_IMAGE
) and dispersed grism images (EXP_TYPE=NIS_WFSS
) are calibrated. In addition to the EXP_TYPE
keyword, the keyword FILTER
can be used to distinguish exposure types for NIRISS WFSS data. FILTER=CLEAR
indicates a direct image while FILTER=GR150R
or FILTER=GR150C
indicates a dispersed image. The keyword PUPIL
is the blocking filter used in both direct images and dispersed images. We can also use the PATT_NUM
, XOFFSET
, and YOFFSET
header keywords to see the dither pattern that was used for both the direct images and the dispersed images. The multiple direct image dithers will be combined in image3, while the multiple dithers in the dispersed images are combined as individual sources after extraction in spec3.
# Print information about each rate file
rate_files = sorted(glob.glob(os.path.join(det1_dir, "*rate.fits")))
for file_num, ratefile in enumerate(rate_files):
rate_hdr = fits.getheader(ratefile) # Primary header for each rate file
# information we want to store that might be useful to us later for evaluating the data
temp_hdr_dict = {"PATHNAME": os.path.abspath(ratefile), # full path to the filename to be used later
"FILENAME": rate_hdr['FILENAME'], # base filename for printing readability
"EXP_TYPE": [rate_hdr['EXP_TYPE']], # NIS_IMAGE or NIS_WFSS
"FILTER": [rate_hdr["FILTER"]], # Grism; GR150R/GR150C
"PUPIL": [rate_hdr["PUPIL"]], # Filter used; F090W, F115W, F140M, F150W F158M, F200W
"EXPSTART": [rate_hdr['EXPSTART']], # Exposure start time (MJD)
"PATT_NUM": [rate_hdr["PATT_NUM"]], # Position number within dither pattern for WFSS
"NUMDTHPT": [rate_hdr["NUMDTHPT"]], # Total number of points in entire dither pattern
"XOFFSET": [rate_hdr["XOFFSET"]], # X offset from pattern starting position for NIRISS (arcsec)
"YOFFSET": [rate_hdr["YOFFSET"]], # Y offset from pattern starting position for NIRISS (arcsec)
"CAL_VER": [rate_hdr["CAL_VER"]], # JWST pipeline calibration version
}
# Turn the dictionary into a pandas dataframe to make it easier to read & use later
if file_num == 0:
# if this is the first file, make an initial dataframe
rate_df = pd.DataFrame(temp_hdr_dict)
else:
# otherwise, append to the dataframe for each file
new_data_df = pd.DataFrame(temp_hdr_dict)
# merge the two dataframes together to create a dataframe with all
rate_df = pd.concat([rate_df, new_data_df], ignore_index=True, axis=0)
rate_dfsort = rate_df.sort_values('EXPSTART', ignore_index=False) # sort by exposure start time
# Look at the resulting dataframe
rate_dfsort[['FILENAME', 'EXP_TYPE', 'FILTER', 'PUPIL', 'EXPSTART', 'PATT_NUM', 'NUMDTHPT', 'XOFFSET', 'YOFFSET', 'CAL_VER']]
FILENAME | EXP_TYPE | FILTER | PUPIL | EXPSTART | PATT_NUM | NUMDTHPT | XOFFSET | YOFFSET | CAL_VER | |
---|---|---|---|---|---|---|---|---|---|---|
0 | jw02079004003_02101_00001_nis_rate.fits | NIS_IMAGE | CLEAR | F200W | 59976.655916 | 1 | 4 | 0.000099 | 9.9490 | 1.19.1 |
1 | jw02079004003_03101_00001_nis_rate.fits | NIS_WFSS | GR150R | F200W | 59976.660812 | 1 | 4 | 0.000099 | 9.9490 | 1.19.1 |
2 | jw02079004003_03101_00002_nis_rate.fits | NIS_WFSS | GR150R | F200W | 59976.722187 | 2 | 4 | 0.567803 | 11.1062 | 1.19.1 |
3 | jw02079004003_03101_00003_nis_rate.fits | NIS_WFSS | GR150R | F200W | 59976.783568 | 3 | 4 | -0.567604 | 8.7918 | 1.19.1 |
4 | jw02079004003_04101_00001_nis_rate.fits | NIS_IMAGE | CLEAR | F200W | 59976.846204 | 1 | 4 | -0.567604 | 8.7918 | 1.19.1 |
5 | jw02079004003_04101_00002_nis_rate.fits | NIS_IMAGE | CLEAR | F200W | 59976.849679 | 2 | 4 | 0.184401 | 8.5907 | 1.19.1 |
6 | jw02079004003_04101_00003_nis_rate.fits | NIS_IMAGE | CLEAR | F200W | 59976.853152 | 3 | 4 | -0.109901 | 9.0203 | 1.19.1 |
7 | jw02079004003_04101_00004_nis_rate.fits | NIS_IMAGE | CLEAR | F200W | 59976.856611 | 4 | 4 | 9.907557 | -0.0464 | 1.19.1 |
8 | jw02079004003_05101_00001_nis_rate.fits | NIS_WFSS | GR150C | F200W | 59976.861511 | 1 | 4 | 9.907557 | -0.0464 | 1.19.1 |
9 | jw02079004003_05101_00002_nis_rate.fits | NIS_WFSS | GR150C | F200W | 59976.922897 | 2 | 4 | 10.475260 | 1.1108 | 1.19.1 |
10 | jw02079004003_05101_00003_nis_rate.fits | NIS_WFSS | GR150C | F200W | 59976.984350 | 3 | 4 | 9.339854 | -1.2036 | 1.19.1 |
11 | jw02079004003_06101_00001_nis_rate.fits | NIS_IMAGE | CLEAR | F200W | 59977.047145 | 1 | 3 | 9.339854 | -1.2036 | 1.19.1 |
12 | jw02079004003_06101_00002_nis_rate.fits | NIS_IMAGE | CLEAR | F200W | 59977.050614 | 2 | 3 | 10.091858 | -1.4047 | 1.19.1 |
13 | jw02079004003_06101_00003_nis_rate.fits | NIS_IMAGE | CLEAR | F200W | 59977.054075 | 3 | 3 | 9.797556 | -0.9751 | 1.19.1 |
Shown below are the rate files to give an idea of the above sequence visually. Grid lines are shown as a visual guide for the dithers
# Quick plot to visually illustrate the table above showing the
# direct image and grism sequence for the downloaded data
if doviz:
# plot set up
fig = plt.figure(figsize=(20, 35))
cols = 3
rows = int(np.ceil(len(rate_dfsort['PATHNAME']) / cols))
# loop over the rate files and plot them
for plt_num, rf in enumerate(rate_dfsort['PATHNAME']):
# determine where the subplot should be
xpos = (plt_num % 40) % cols
ypos = ((plt_num % 40) // cols) # // to make it an int.
# make the subplot
ax = plt.subplot2grid((rows, cols), (ypos, xpos))
# open the data and plot it
with fits.open(rf) as hdu:
data = hdu[1].data
data[np.isnan(data)] = 0 # filling in nan data with 0s to help with the matplotlib color scale.
display_vals = [np.nanpercentile(data, 1), np.nanpercentile(data, 99.5)]
ax.imshow(data, vmin=display_vals[0], vmax=display_vals[1], origin='lower')
# adding in grid lines as a visual aid
for gridline in [500, 1000, 1500]:
ax.axhline(gridline, color='black', alpha=0.5)
ax.axvline(gridline, color='black', alpha=0.5)
ax.set_title(f"#{plt_num+1}: {hdu[0].header['EXP_TYPE']} {hdu[0].header['FILTER']} {hdu[0].header['PUPIL']} Dither{hdu[0].header['PATT_NUM']}")
fig.suptitle(f'PID{program} o{sci_observtn} Observing Sequence rate Images (pixel space)', fontsize=16, x=0.5, y=0.9)

Additionally, you can look into what steps were performed and reference files used during the Detector1 stage of the pipeline. These calls can be used at any stage of the pipeline to see or confirm what different steps or reference files were used. We show both the direct image and the dispersed (grism) images below.
# first look at the direct images
dir_img_rate = rate_dfsort[rate_dfsort['EXP_TYPE'] == 'NIS_IMAGE']['PATHNAME'].iloc[0]
check_steps_run(dir_img_rate)
# then look at the dispersed, grism images
grism_img_rate = rate_dfsort[rate_dfsort['EXP_TYPE'] == 'NIS_WFSS']['PATHNAME'].iloc[0]
check_steps_run(grism_img_rate)
jw02079004003_02101_00001_nis_rate.fits - NIS_IMAGE
charge_migration: COMPLETE
clean_flicker_noise: SKIPPED
dark_sub: COMPLETE
dq_init: COMPLETE
gain_scale: SKIPPED
group_scale: SKIPPED
ipc: SKIPPED
jump: COMPLETE
linearity: COMPLETE
persistence: COMPLETE
ramp_fit: COMPLETE
refpix: COMPLETE
saturation: COMPLETE
superbias: COMPLETE
jw02079004003_03101_00001_nis_rate.fits - NIS_WFSS
charge_migration: COMPLETE
clean_flicker_noise: SKIPPED
dark_sub: COMPLETE
dq_init: COMPLETE
gain_scale: SKIPPED
group_scale: SKIPPED
ipc: SKIPPED
jump: COMPLETE
linearity: COMPLETE
persistence: COMPLETE
ramp_fit: COMPLETE
refpix: COMPLETE
saturation: COMPLETE
superbias: COMPLETE
check_ref_file_used(dir_img_rate) # direct image
check_ref_file_used(grism_img_rate) # dispersed image
jw02079004003_02101_00001_nis_rate.fits - NIS_IMAGE
crds: {'context_used': 'jwst_1413.pmap', 'sw_version': '13.0.4'}
dark: {'name': 'crds://jwst_niriss_dark_0228.fits'}
gain: {'name': 'crds://jwst_niriss_gain_0006.fits'}
linearity: {'name': 'crds://jwst_niriss_linearity_0017.fits'}
mask: {'name': 'crds://jwst_niriss_mask_0035.fits'}
persat: {'name': 'crds://jwst_niriss_persat_0004.fits'}
readnoise: {'name': 'crds://jwst_niriss_readnoise_0005.fits'}
saturation: {'name': 'crds://jwst_niriss_saturation_0015.fits'}
superbias: {'name': 'crds://jwst_niriss_superbias_0238.fits'}
trapdensity: {'name': 'crds://jwst_niriss_trapdensity_0002.fits'}
trappars: {'name': 'crds://jwst_niriss_trappars_0002.fits'}
jw02079004003_03101_00001_nis_rate.fits - NIS_WFSS
crds: {'context_used': 'jwst_1413.pmap', 'sw_version': '13.0.4'}
dark: {'name': 'crds://jwst_niriss_dark_0228.fits'}
gain: {'name': 'crds://jwst_niriss_gain_0006.fits'}
linearity: {'name': 'crds://jwst_niriss_linearity_0017.fits'}
mask: {'name': 'crds://jwst_niriss_mask_0035.fits'}
persat: {'name': 'crds://jwst_niriss_persat_0004.fits'}
readnoise: {'name': 'crds://jwst_niriss_readnoise_0005.fits'}
saturation: {'name': 'crds://jwst_niriss_saturation_0015.fits'}
superbias: {'name': 'crds://jwst_niriss_superbias_0238.fits'}
trapdensity: {'name': 'crds://jwst_niriss_trapdensity_0002.fits'}
trappars: {'name': 'crds://jwst_niriss_trappars_0002.fits'}
# Print out the time benchmark
time_det1_end = time.perf_counter()
print(f"Runtime for Detector1: {(time_det1_end - time_det1_start)/60:0.0f} minutes")
Runtime for Detector1: 53 minutes
6. Image2 Pipeline#
This section focuses on calibrating only the direct images in order to obtain a source catalog and segmentation mapping of the field to use as input into the Spec2 stage later.
In the Image2 stage of the pipeline, calibrated unrectified data products are created (*_cal.fits
files). In this pipeline processing stage, the world coordinate system (WCS) is assigned, the data are flat fielded, and a photometric calibration is applied to convert from units of countrate (ADU/s) to surface brightness (MJy/sr).
By default, the background subtraction step and the resampling step are not performed for NIRISS at this stage of the pipeline. The background subtraction is turned off since there is no background template for the imaging mode and the local background is removed during the background correction for photometric measurements around individual sources. The resampling step occurs during the Image3 stage by default. While the resampling step can be turned on during the Image2 stage to, e.g., generate a source catalog for each image, the data quality from the Image3 stage will be better since the bad pixels, which adversely affect both the centroids and photometry in individual images, will be mostly removed.
For NIRISS imaging, it is equivalent to run the Image2 pipeline directly on the imaging rate files versus on the Image2 association files. Therefore, here we will simply use the dataframe table we set up in the Detector1 stage to filter on the imaging rate files and calibrate those directly rather than calibrating with the association files. To use the association files, simply replace the rate filename in the call with the association filename.
time_image2 = time.perf_counter()
The parameters in each of the Image2 steps can be modified from the default values, including overwriting reference files that are used during this stage. This dictionary of the modified parameters for each of the steps is then fed into the steps
parameter of the Image2Pipeline
call. The syntax for modifying some of these parameters is below.
# Set up a dictionary to define how the Image2 pipeline should be configured.
# this sets up any entry to image2dict to be a dictionary itself
image2dict = defaultdict(dict)
# -----------------------------Set step parameters------------------------------
# Example overrides for whether or not certain steps should be skipped
# image2dict['resample']['skip'] = False
# ---------------------------Override reference files---------------------------
# Example overrides for various reference files
# Files should be in the base local directory or provide full path
# image2dict['assign_wcs']['override_distortion'] = 'myfile.asdf' # Spatial distortion (ASDF file)
# image2dict['assign_wcs']['override_filteroffset'] = 'myfile.asdf' # Imager filter offsets (ASDF file)
# image2dict['assign_wcs']['override_specwcs'] = 'myfile.asdf' # Spectral distortion (ASDF file)
# image2dict['assign_wcs']['override_wavelengthrange'] = 'myfile.asdf' # Wavelength channel mapping (ASDF file)
# image2dict['flat_field']['override_flat'] = 'myfile.fits' # Pixel flatfield
# image2dict['photom']['override_photom'] = 'myfile.fits' # Photometric calibration array
img_rate_files = rate_dfsort[rate_dfsort['EXP_TYPE'] == 'NIS_IMAGE']['PATHNAME']
print(f'Found {str(len(img_rate_files))} imaging rate files to process for level 2')
Found 8 imaging rate files to process for level 2
# Run Image2 stage of pipeline, specifying:
# output directory to save *_cal.fits files
# save_results flag set to True so the rate files are saved
if doimage2:
for rate in img_rate_files:
img2 = Image2Pipeline.call(rate, output_dir=image2_dir, steps=image2dict, save_results=True)
else:
print("Skipping Image2 processing.")
2025-09-13 16:25:20,034 - CRDS - INFO - Fetching /home/runner/crds/references/jwst/niriss/jwst_niriss_pars-resamplestep_0001.asdf 1.2 K bytes (1 / 1 files) (0 / 1.2 K bytes)
2025-09-13 16:25:20,287 - stpipe - INFO - PARS-RESAMPLESTEP parameters found: /home/runner/crds/references/jwst/niriss/jwst_niriss_pars-resamplestep_0001.asdf
2025-09-13 16:25:20,296 - CRDS - INFO - Fetching /home/runner/crds/references/jwst/niriss/jwst_niriss_pars-image2pipeline_0002.asdf 1.3 K bytes (1 / 1 files) (0 / 1.3 K bytes)
2025-09-13 16:25:20,546 - stpipe - INFO - PARS-IMAGE2PIPELINE parameters found: /home/runner/crds/references/jwst/niriss/jwst_niriss_pars-image2pipeline_0002.asdf
2025-09-13 16:25:20,557 - stpipe.Image2Pipeline - INFO - Image2Pipeline instance created.
2025-09-13 16:25:20,558 - stpipe.Image2Pipeline.bkg_subtract - INFO - BackgroundStep instance created.
2025-09-13 16:25:20,559 - stpipe.Image2Pipeline.assign_wcs - INFO - AssignWcsStep instance created.
2025-09-13 16:25:20,560 - stpipe.Image2Pipeline.flat_field - INFO - FlatFieldStep instance created.
2025-09-13 16:25:20,561 - stpipe.Image2Pipeline.photom - INFO - PhotomStep instance created.
2025-09-13 16:25:20,562 - stpipe.Image2Pipeline.resample - INFO - ResampleStep instance created.
2025-09-13 16:25:20,776 - stpipe.Image2Pipeline - INFO - Step Image2Pipeline running with args ('/home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage1/jw02079004003_02101_00001_nis_rate.fits',).
2025-09-13 16:25:20,784 - stpipe.Image2Pipeline - INFO - Step Image2Pipeline parameters are:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage2_img
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: True
skip: False
suffix: None
search_output_file: True
input_dir: ''
save_bsub: False
steps:
bkg_subtract:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: True
suffix: None
search_output_file: True
input_dir: ''
bkg_list: None
save_combined_background: False
sigma: 3.0
maxiters: None
soss_source_percentile: 35.0
soss_bkg_percentile: None
wfss_mmag_extract: None
wfss_maxiter: 5
wfss_rms_stop: 0.0
wfss_outlier_percent: 1.0
assign_wcs:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
sip_approx: True
sip_max_pix_error: 0.01
sip_degree: None
sip_max_inv_pix_error: 0.01
sip_inv_degree: None
sip_npoints: 12
slit_y_low: -0.55
slit_y_high: 0.55
nrs_ifu_slice_wcs: False
flat_field:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
save_interpolated_flat: False
user_supplied_flat: None
inverse: False
photom:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
inverse: False
source_type: None
mrs_time_correction: True
resample:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: True
suffix: None
search_output_file: True
input_dir: ''
pixfrac: 1.0
kernel: square
fillval: NAN
weight_type: ivm
output_shape: None
crpix: None
crval: None
rotation: None
pixel_scale_ratio: 1.0
pixel_scale: None
output_wcs: ''
single: False
blendheaders: True
in_memory: True
enable_ctx: True
enable_err: True
report_var: True
2025-09-13 16:25:20,803 - stpipe.Image2Pipeline - INFO - Prefetching reference files for dataset: 'jw02079004003_02101_00001_nis_rate.fits' reftypes = ['area', 'camera', 'collimator', 'dflat', 'disperser', 'distortion', 'fflat', 'filteroffset', 'flat', 'fore', 'fpa', 'ifufore', 'ifupost', 'ifuslicer', 'msa', 'ote', 'photom', 'regions', 'sflat', 'specwcs', 'wavelengthrange']
2025-09-13 16:25:20,806 - CRDS - INFO - Fetching /home/runner/crds/references/jwst/niriss/jwst_niriss_area_0017.fits 16.8 M bytes (1 / 5 files) (0 / 84.0 M bytes)
2025-09-13 16:25:46,985 - CRDS - INFO - Fetching /home/runner/crds/references/jwst/niriss/jwst_niriss_distortion_0037.asdf 9.9 K bytes (2 / 5 files) (16.8 M / 84.0 M bytes)
2025-09-13 16:25:47,230 - CRDS - INFO - Fetching /home/runner/crds/references/jwst/niriss/jwst_niriss_filteroffset_0006.asdf 5.4 K bytes (3 / 5 files) (16.8 M / 84.0 M bytes)
2025-09-13 16:25:47,473 - CRDS - INFO - Fetching /home/runner/crds/references/jwst/niriss/jwst_niriss_flat_0268.fits 67.1 M bytes (4 / 5 files) (16.8 M / 84.0 M bytes)
2025-09-13 16:27:17,851 - CRDS - INFO - Fetching /home/runner/crds/references/jwst/niriss/jwst_niriss_photom_0046.fits 14.4 K bytes (5 / 5 files) (83.9 M / 84.0 M bytes)
2025-09-13 16:27:18,167 - stpipe.Image2Pipeline - INFO - Prefetch for AREA reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_area_0017.fits'.
2025-09-13 16:27:18,167 - stpipe.Image2Pipeline - INFO - Prefetch for CAMERA reference file is 'N/A'.
2025-09-13 16:27:18,168 - stpipe.Image2Pipeline - INFO - Prefetch for COLLIMATOR reference file is 'N/A'.
2025-09-13 16:27:18,168 - stpipe.Image2Pipeline - INFO - Prefetch for DFLAT reference file is 'N/A'.
2025-09-13 16:27:18,169 - stpipe.Image2Pipeline - INFO - Prefetch for DISPERSER reference file is 'N/A'.
2025-09-13 16:27:18,169 - stpipe.Image2Pipeline - INFO - Prefetch for DISTORTION reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_distortion_0037.asdf'.
2025-09-13 16:27:18,169 - stpipe.Image2Pipeline - INFO - Prefetch for FFLAT reference file is 'N/A'.
2025-09-13 16:27:18,170 - stpipe.Image2Pipeline - INFO - Prefetch for FILTEROFFSET reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_filteroffset_0006.asdf'.
2025-09-13 16:27:18,170 - stpipe.Image2Pipeline - INFO - Prefetch for FLAT reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_flat_0268.fits'.
2025-09-13 16:27:18,170 - stpipe.Image2Pipeline - INFO - Prefetch for FORE reference file is 'N/A'.
2025-09-13 16:27:18,171 - stpipe.Image2Pipeline - INFO - Prefetch for FPA reference file is 'N/A'.
2025-09-13 16:27:18,171 - stpipe.Image2Pipeline - INFO - Prefetch for IFUFORE reference file is 'N/A'.
2025-09-13 16:27:18,171 - stpipe.Image2Pipeline - INFO - Prefetch for IFUPOST reference file is 'N/A'.
2025-09-13 16:27:18,172 - stpipe.Image2Pipeline - INFO - Prefetch for IFUSLICER reference file is 'N/A'.
2025-09-13 16:27:18,172 - stpipe.Image2Pipeline - INFO - Prefetch for MSA reference file is 'N/A'.
2025-09-13 16:27:18,172 - stpipe.Image2Pipeline - INFO - Prefetch for OTE reference file is 'N/A'.
2025-09-13 16:27:18,172 - stpipe.Image2Pipeline - INFO - Prefetch for PHOTOM reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_photom_0046.fits'.
2025-09-13 16:27:18,173 - stpipe.Image2Pipeline - INFO - Prefetch for REGIONS reference file is 'N/A'.
2025-09-13 16:27:18,173 - stpipe.Image2Pipeline - INFO - Prefetch for SFLAT reference file is 'N/A'.
2025-09-13 16:27:18,173 - stpipe.Image2Pipeline - INFO - Prefetch for SPECWCS reference file is 'N/A'.
2025-09-13 16:27:18,174 - stpipe.Image2Pipeline - INFO - Prefetch for WAVELENGTHRANGE reference file is 'N/A'.
2025-09-13 16:27:18,174 - stpipe.Image2Pipeline - INFO - Starting calwebb_image2 ...
2025-09-13 16:27:18,175 - stpipe.Image2Pipeline - INFO - Processing product /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage1/jw02079004003_02101_00001_nis
2025-09-13 16:27:18,175 - stpipe.Image2Pipeline - INFO - Working on input /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage1/jw02079004003_02101_00001_nis_rate.fits ...
2025-09-13 16:27:18,415 - stpipe.Image2Pipeline.assign_wcs - INFO - Step assign_wcs running with args (<ImageModel(2048, 2048) from /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage2_img/jw02079004003_02101_00001_nis_image2pipeline.fits>,).
2025-09-13 16:27:18,558 - jwst.assign_wcs.niriss - INFO - Offsets from filteroffset file are 2.119, -1.0476
2025-09-13 16:27:18,620 - stcal.alignment.util - INFO - Update S_REGION to POLYGON ICRS 53.145039315 -27.807881991 53.184914294 -27.795426661 53.170743539 -27.760472003 53.130903944 -27.772905257
2025-09-13 16:27:18,621 - jwst.assign_wcs.assign_wcs - INFO - assign_wcs updated S_REGION to POLYGON ICRS 53.145039315 -27.807881991 53.184914294 -27.795426661 53.170743539 -27.760472003 53.130903944 -27.772905257
2025-09-13 16:27:18,621 - jwst.assign_wcs.assign_wcs - INFO - COMPLETED assign_wcs
2025-09-13 16:27:18,677 - stpipe.Image2Pipeline.assign_wcs - INFO - Step assign_wcs done
2025-09-13 16:27:18,875 - stpipe.Image2Pipeline.flat_field - INFO - Step flat_field running with args (<ImageModel(2048, 2048) from /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage2_img/jw02079004003_02101_00001_nis_image2pipeline.fits>,).
2025-09-13 16:27:18,958 - stpipe.Image2Pipeline.flat_field - INFO - Using FLAT reference file: /home/runner/crds/references/jwst/niriss/jwst_niriss_flat_0268.fits
2025-09-13 16:27:18,959 - stpipe.Image2Pipeline.flat_field - INFO - No reference found for type FFLAT
2025-09-13 16:27:18,959 - stpipe.Image2Pipeline.flat_field - INFO - No reference found for type SFLAT
2025-09-13 16:27:18,960 - stpipe.Image2Pipeline.flat_field - INFO - No reference found for type DFLAT
2025-09-13 16:27:19,128 - stpipe.Image2Pipeline.flat_field - INFO - Step flat_field done
2025-09-13 16:27:19,329 - stpipe.Image2Pipeline.photom - INFO - Step photom running with args (<ImageModel(2048, 2048) from /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage2_img/jw02079004003_02101_00001_nis_image2pipeline.fits>,).
2025-09-13 16:27:19,344 - stpipe.Image2Pipeline.photom - INFO - Using photom reference file: /home/runner/crds/references/jwst/niriss/jwst_niriss_photom_0046.fits
2025-09-13 16:27:19,345 - stpipe.Image2Pipeline.photom - INFO - Using area reference file: /home/runner/crds/references/jwst/niriss/jwst_niriss_area_0017.fits
2025-09-13 16:27:19,376 - jwst.photom.photom - INFO - Using instrument: NIRISS
2025-09-13 16:27:19,377 - jwst.photom.photom - INFO - detector: NIS
2025-09-13 16:27:19,378 - jwst.photom.photom - INFO - exp_type: NIS_IMAGE
2025-09-13 16:27:19,378 - jwst.photom.photom - INFO - filter: CLEAR
2025-09-13 16:27:19,379 - jwst.photom.photom - INFO - pupil: F200W
2025-09-13 16:27:19,407 - jwst.photom.photom - INFO - Pixel area map copied to output.
2025-09-13 16:27:19,408 - jwst.photom.photom - INFO - Values for PIXAR_SR and PIXAR_A2 obtained from AREA reference file.
2025-09-13 16:27:19,409 - jwst.photom.photom - INFO - PHOTMJSR value: 0.258197
2025-09-13 16:27:19,460 - stpipe.Image2Pipeline.photom - INFO - Step photom done
2025-09-13 16:27:19,664 - stpipe.Image2Pipeline.resample - INFO - Step resample running with args (<ImageModel(2048, 2048) from /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage2_img/jw02079004003_02101_00001_nis_image2pipeline.fits>,).
2025-09-13 16:27:19,665 - stpipe.Image2Pipeline.resample - INFO - Step skipped.
2025-09-13 16:27:19,666 - stpipe.Image2Pipeline - INFO - Finished processing product /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage1/jw02079004003_02101_00001_nis
2025-09-13 16:27:19,667 - stpipe.Image2Pipeline - INFO - ... ending calwebb_image2
2025-09-13 16:27:19,668 - jwst.stpipe.core - INFO - Results used CRDS context: jwst_1413.pmap
2025-09-13 16:27:19,842 - stpipe.Image2Pipeline - INFO - Saved model in /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage2_img/jw02079004003_02101_00001_nis_cal.fits
2025-09-13 16:27:19,843 - stpipe.Image2Pipeline - INFO - Step Image2Pipeline done
2025-09-13 16:27:19,843 - jwst.stpipe.core - INFO - Results used jwst version: 1.19.1
2025-09-13 16:27:19,866 - stpipe - INFO - PARS-RESAMPLESTEP parameters found: /home/runner/crds/references/jwst/niriss/jwst_niriss_pars-resamplestep_0001.asdf
2025-09-13 16:27:19,874 - stpipe - INFO - PARS-IMAGE2PIPELINE parameters found: /home/runner/crds/references/jwst/niriss/jwst_niriss_pars-image2pipeline_0002.asdf
2025-09-13 16:27:19,885 - stpipe.Image2Pipeline - INFO - Image2Pipeline instance created.
2025-09-13 16:27:19,886 - stpipe.Image2Pipeline.bkg_subtract - INFO - BackgroundStep instance created.
2025-09-13 16:27:19,887 - stpipe.Image2Pipeline.assign_wcs - INFO - AssignWcsStep instance created.
2025-09-13 16:27:19,888 - stpipe.Image2Pipeline.flat_field - INFO - FlatFieldStep instance created.
2025-09-13 16:27:19,889 - stpipe.Image2Pipeline.photom - INFO - PhotomStep instance created.
2025-09-13 16:27:19,890 - stpipe.Image2Pipeline.resample - INFO - ResampleStep instance created.
2025-09-13 16:27:20,098 - stpipe.Image2Pipeline - INFO - Step Image2Pipeline running with args ('/home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage1/jw02079004003_04101_00001_nis_rate.fits',).
2025-09-13 16:27:20,105 - stpipe.Image2Pipeline - INFO - Step Image2Pipeline parameters are:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage2_img
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: True
skip: False
suffix: None
search_output_file: True
input_dir: ''
save_bsub: False
steps:
bkg_subtract:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: True
suffix: None
search_output_file: True
input_dir: ''
bkg_list: None
save_combined_background: False
sigma: 3.0
maxiters: None
soss_source_percentile: 35.0
soss_bkg_percentile: None
wfss_mmag_extract: None
wfss_maxiter: 5
wfss_rms_stop: 0.0
wfss_outlier_percent: 1.0
assign_wcs:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
sip_approx: True
sip_max_pix_error: 0.01
sip_degree: None
sip_max_inv_pix_error: 0.01
sip_inv_degree: None
sip_npoints: 12
slit_y_low: -0.55
slit_y_high: 0.55
nrs_ifu_slice_wcs: False
flat_field:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
save_interpolated_flat: False
user_supplied_flat: None
inverse: False
photom:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
inverse: False
source_type: None
mrs_time_correction: True
resample:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: True
suffix: None
search_output_file: True
input_dir: ''
pixfrac: 1.0
kernel: square
fillval: NAN
weight_type: ivm
output_shape: None
crpix: None
crval: None
rotation: None
pixel_scale_ratio: 1.0
pixel_scale: None
output_wcs: ''
single: False
blendheaders: True
in_memory: True
enable_ctx: True
enable_err: True
report_var: True
2025-09-13 16:27:20,124 - stpipe.Image2Pipeline - INFO - Prefetching reference files for dataset: 'jw02079004003_04101_00001_nis_rate.fits' reftypes = ['area', 'camera', 'collimator', 'dflat', 'disperser', 'distortion', 'fflat', 'filteroffset', 'flat', 'fore', 'fpa', 'ifufore', 'ifupost', 'ifuslicer', 'msa', 'ote', 'photom', 'regions', 'sflat', 'specwcs', 'wavelengthrange']
2025-09-13 16:27:20,127 - stpipe.Image2Pipeline - INFO - Prefetch for AREA reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_area_0017.fits'.
2025-09-13 16:27:20,127 - stpipe.Image2Pipeline - INFO - Prefetch for CAMERA reference file is 'N/A'.
2025-09-13 16:27:20,127 - stpipe.Image2Pipeline - INFO - Prefetch for COLLIMATOR reference file is 'N/A'.
2025-09-13 16:27:20,128 - stpipe.Image2Pipeline - INFO - Prefetch for DFLAT reference file is 'N/A'.
2025-09-13 16:27:20,128 - stpipe.Image2Pipeline - INFO - Prefetch for DISPERSER reference file is 'N/A'.
2025-09-13 16:27:20,129 - stpipe.Image2Pipeline - INFO - Prefetch for DISTORTION reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_distortion_0037.asdf'.
2025-09-13 16:27:20,129 - stpipe.Image2Pipeline - INFO - Prefetch for FFLAT reference file is 'N/A'.
2025-09-13 16:27:20,130 - stpipe.Image2Pipeline - INFO - Prefetch for FILTEROFFSET reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_filteroffset_0006.asdf'.
2025-09-13 16:27:20,130 - stpipe.Image2Pipeline - INFO - Prefetch for FLAT reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_flat_0268.fits'.
2025-09-13 16:27:20,130 - stpipe.Image2Pipeline - INFO - Prefetch for FORE reference file is 'N/A'.
2025-09-13 16:27:20,131 - stpipe.Image2Pipeline - INFO - Prefetch for FPA reference file is 'N/A'.
2025-09-13 16:27:20,131 - stpipe.Image2Pipeline - INFO - Prefetch for IFUFORE reference file is 'N/A'.
2025-09-13 16:27:20,131 - stpipe.Image2Pipeline - INFO - Prefetch for IFUPOST reference file is 'N/A'.
2025-09-13 16:27:20,132 - stpipe.Image2Pipeline - INFO - Prefetch for IFUSLICER reference file is 'N/A'.
2025-09-13 16:27:20,132 - stpipe.Image2Pipeline - INFO - Prefetch for MSA reference file is 'N/A'.
2025-09-13 16:27:20,133 - stpipe.Image2Pipeline - INFO - Prefetch for OTE reference file is 'N/A'.
2025-09-13 16:27:20,133 - stpipe.Image2Pipeline - INFO - Prefetch for PHOTOM reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_photom_0046.fits'.
2025-09-13 16:27:20,133 - stpipe.Image2Pipeline - INFO - Prefetch for REGIONS reference file is 'N/A'.
2025-09-13 16:27:20,134 - stpipe.Image2Pipeline - INFO - Prefetch for SFLAT reference file is 'N/A'.
2025-09-13 16:27:20,134 - stpipe.Image2Pipeline - INFO - Prefetch for SPECWCS reference file is 'N/A'.
2025-09-13 16:27:20,134 - stpipe.Image2Pipeline - INFO - Prefetch for WAVELENGTHRANGE reference file is 'N/A'.
2025-09-13 16:27:20,135 - stpipe.Image2Pipeline - INFO - Starting calwebb_image2 ...
2025-09-13 16:27:20,135 - stpipe.Image2Pipeline - INFO - Processing product /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage1/jw02079004003_04101_00001_nis
2025-09-13 16:27:20,135 - stpipe.Image2Pipeline - INFO - Working on input /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage1/jw02079004003_04101_00001_nis_rate.fits ...
2025-09-13 16:27:20,392 - stpipe.Image2Pipeline.assign_wcs - INFO - Step assign_wcs running with args (<ImageModel(2048, 2048) from /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage2_img/jw02079004003_04101_00001_nis_image2pipeline.fits>,).
2025-09-13 16:27:20,475 - jwst.assign_wcs.niriss - INFO - Offsets from filteroffset file are 2.119, -1.0476
2025-09-13 16:27:20,527 - stcal.alignment.util - INFO - Update S_REGION to POLYGON ICRS 53.145322488 -27.807626701 53.185197303 -27.795171197 53.171026385 -27.760216600 53.131186953 -27.772650030
2025-09-13 16:27:20,528 - jwst.assign_wcs.assign_wcs - INFO - assign_wcs updated S_REGION to POLYGON ICRS 53.145322488 -27.807626701 53.185197303 -27.795171197 53.171026385 -27.760216600 53.131186953 -27.772650030
2025-09-13 16:27:20,529 - jwst.assign_wcs.assign_wcs - INFO - COMPLETED assign_wcs
2025-09-13 16:27:20,573 - stpipe.Image2Pipeline.assign_wcs - INFO - Step assign_wcs done
2025-09-13 16:27:20,779 - stpipe.Image2Pipeline.flat_field - INFO - Step flat_field running with args (<ImageModel(2048, 2048) from /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage2_img/jw02079004003_04101_00001_nis_image2pipeline.fits>,).
2025-09-13 16:27:20,844 - stpipe.Image2Pipeline.flat_field - INFO - Using FLAT reference file: /home/runner/crds/references/jwst/niriss/jwst_niriss_flat_0268.fits
2025-09-13 16:27:20,845 - stpipe.Image2Pipeline.flat_field - INFO - No reference found for type FFLAT
2025-09-13 16:27:20,845 - stpipe.Image2Pipeline.flat_field - INFO - No reference found for type SFLAT
2025-09-13 16:27:20,845 - stpipe.Image2Pipeline.flat_field - INFO - No reference found for type DFLAT
2025-09-13 16:27:21,008 - stpipe.Image2Pipeline.flat_field - INFO - Step flat_field done
2025-09-13 16:27:21,217 - stpipe.Image2Pipeline.photom - INFO - Step photom running with args (<ImageModel(2048, 2048) from /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage2_img/jw02079004003_04101_00001_nis_image2pipeline.fits>,).
2025-09-13 16:27:21,228 - stpipe.Image2Pipeline.photom - INFO - Using photom reference file: /home/runner/crds/references/jwst/niriss/jwst_niriss_photom_0046.fits
2025-09-13 16:27:21,229 - stpipe.Image2Pipeline.photom - INFO - Using area reference file: /home/runner/crds/references/jwst/niriss/jwst_niriss_area_0017.fits
2025-09-13 16:27:21,262 - jwst.photom.photom - INFO - Using instrument: NIRISS
2025-09-13 16:27:21,263 - jwst.photom.photom - INFO - detector: NIS
2025-09-13 16:27:21,264 - jwst.photom.photom - INFO - exp_type: NIS_IMAGE
2025-09-13 16:27:21,264 - jwst.photom.photom - INFO - filter: CLEAR
2025-09-13 16:27:21,265 - jwst.photom.photom - INFO - pupil: F200W
2025-09-13 16:27:21,289 - jwst.photom.photom - INFO - Pixel area map copied to output.
2025-09-13 16:27:21,290 - jwst.photom.photom - INFO - Values for PIXAR_SR and PIXAR_A2 obtained from AREA reference file.
2025-09-13 16:27:21,291 - jwst.photom.photom - INFO - PHOTMJSR value: 0.258197
2025-09-13 16:27:21,342 - stpipe.Image2Pipeline.photom - INFO - Step photom done
2025-09-13 16:27:21,549 - stpipe.Image2Pipeline.resample - INFO - Step resample running with args (<ImageModel(2048, 2048) from /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage2_img/jw02079004003_04101_00001_nis_image2pipeline.fits>,).
2025-09-13 16:27:21,550 - stpipe.Image2Pipeline.resample - INFO - Step skipped.
2025-09-13 16:27:21,551 - stpipe.Image2Pipeline - INFO - Finished processing product /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage1/jw02079004003_04101_00001_nis
2025-09-13 16:27:21,552 - stpipe.Image2Pipeline - INFO - ... ending calwebb_image2
2025-09-13 16:27:21,552 - jwst.stpipe.core - INFO - Results used CRDS context: jwst_1413.pmap
2025-09-13 16:27:21,725 - stpipe.Image2Pipeline - INFO - Saved model in /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage2_img/jw02079004003_04101_00001_nis_cal.fits
2025-09-13 16:27:21,725 - stpipe.Image2Pipeline - INFO - Step Image2Pipeline done
2025-09-13 16:27:21,726 - jwst.stpipe.core - INFO - Results used jwst version: 1.19.1
2025-09-13 16:27:21,748 - stpipe - INFO - PARS-RESAMPLESTEP parameters found: /home/runner/crds/references/jwst/niriss/jwst_niriss_pars-resamplestep_0001.asdf
2025-09-13 16:27:21,756 - stpipe - INFO - PARS-IMAGE2PIPELINE parameters found: /home/runner/crds/references/jwst/niriss/jwst_niriss_pars-image2pipeline_0002.asdf
2025-09-13 16:27:21,767 - stpipe.Image2Pipeline - INFO - Image2Pipeline instance created.
2025-09-13 16:27:21,768 - stpipe.Image2Pipeline.bkg_subtract - INFO - BackgroundStep instance created.
2025-09-13 16:27:21,769 - stpipe.Image2Pipeline.assign_wcs - INFO - AssignWcsStep instance created.
2025-09-13 16:27:21,770 - stpipe.Image2Pipeline.flat_field - INFO - FlatFieldStep instance created.
2025-09-13 16:27:21,771 - stpipe.Image2Pipeline.photom - INFO - PhotomStep instance created.
2025-09-13 16:27:21,772 - stpipe.Image2Pipeline.resample - INFO - ResampleStep instance created.
2025-09-13 16:27:21,979 - stpipe.Image2Pipeline - INFO - Step Image2Pipeline running with args ('/home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage1/jw02079004003_04101_00002_nis_rate.fits',).
2025-09-13 16:27:21,986 - stpipe.Image2Pipeline - INFO - Step Image2Pipeline parameters are:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage2_img
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: True
skip: False
suffix: None
search_output_file: True
input_dir: ''
save_bsub: False
steps:
bkg_subtract:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: True
suffix: None
search_output_file: True
input_dir: ''
bkg_list: None
save_combined_background: False
sigma: 3.0
maxiters: None
soss_source_percentile: 35.0
soss_bkg_percentile: None
wfss_mmag_extract: None
wfss_maxiter: 5
wfss_rms_stop: 0.0
wfss_outlier_percent: 1.0
assign_wcs:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
sip_approx: True
sip_max_pix_error: 0.01
sip_degree: None
sip_max_inv_pix_error: 0.01
sip_inv_degree: None
sip_npoints: 12
slit_y_low: -0.55
slit_y_high: 0.55
nrs_ifu_slice_wcs: False
flat_field:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
save_interpolated_flat: False
user_supplied_flat: None
inverse: False
photom:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
inverse: False
source_type: None
mrs_time_correction: True
resample:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: True
suffix: None
search_output_file: True
input_dir: ''
pixfrac: 1.0
kernel: square
fillval: NAN
weight_type: ivm
output_shape: None
crpix: None
crval: None
rotation: None
pixel_scale_ratio: 1.0
pixel_scale: None
output_wcs: ''
single: False
blendheaders: True
in_memory: True
enable_ctx: True
enable_err: True
report_var: True
2025-09-13 16:27:22,006 - stpipe.Image2Pipeline - INFO - Prefetching reference files for dataset: 'jw02079004003_04101_00002_nis_rate.fits' reftypes = ['area', 'camera', 'collimator', 'dflat', 'disperser', 'distortion', 'fflat', 'filteroffset', 'flat', 'fore', 'fpa', 'ifufore', 'ifupost', 'ifuslicer', 'msa', 'ote', 'photom', 'regions', 'sflat', 'specwcs', 'wavelengthrange']
2025-09-13 16:27:22,008 - stpipe.Image2Pipeline - INFO - Prefetch for AREA reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_area_0017.fits'.
2025-09-13 16:27:22,009 - stpipe.Image2Pipeline - INFO - Prefetch for CAMERA reference file is 'N/A'.
2025-09-13 16:27:22,009 - stpipe.Image2Pipeline - INFO - Prefetch for COLLIMATOR reference file is 'N/A'.
2025-09-13 16:27:22,009 - stpipe.Image2Pipeline - INFO - Prefetch for DFLAT reference file is 'N/A'.
2025-09-13 16:27:22,010 - stpipe.Image2Pipeline - INFO - Prefetch for DISPERSER reference file is 'N/A'.
2025-09-13 16:27:22,010 - stpipe.Image2Pipeline - INFO - Prefetch for DISTORTION reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_distortion_0037.asdf'.
2025-09-13 16:27:22,011 - stpipe.Image2Pipeline - INFO - Prefetch for FFLAT reference file is 'N/A'.
2025-09-13 16:27:22,011 - stpipe.Image2Pipeline - INFO - Prefetch for FILTEROFFSET reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_filteroffset_0006.asdf'.
2025-09-13 16:27:22,012 - stpipe.Image2Pipeline - INFO - Prefetch for FLAT reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_flat_0268.fits'.
2025-09-13 16:27:22,012 - stpipe.Image2Pipeline - INFO - Prefetch for FORE reference file is 'N/A'.
2025-09-13 16:27:22,013 - stpipe.Image2Pipeline - INFO - Prefetch for FPA reference file is 'N/A'.
2025-09-13 16:27:22,013 - stpipe.Image2Pipeline - INFO - Prefetch for IFUFORE reference file is 'N/A'.
2025-09-13 16:27:22,013 - stpipe.Image2Pipeline - INFO - Prefetch for IFUPOST reference file is 'N/A'.
2025-09-13 16:27:22,014 - stpipe.Image2Pipeline - INFO - Prefetch for IFUSLICER reference file is 'N/A'.
2025-09-13 16:27:22,014 - stpipe.Image2Pipeline - INFO - Prefetch for MSA reference file is 'N/A'.
2025-09-13 16:27:22,014 - stpipe.Image2Pipeline - INFO - Prefetch for OTE reference file is 'N/A'.
2025-09-13 16:27:22,015 - stpipe.Image2Pipeline - INFO - Prefetch for PHOTOM reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_photom_0046.fits'.
2025-09-13 16:27:22,015 - stpipe.Image2Pipeline - INFO - Prefetch for REGIONS reference file is 'N/A'.
2025-09-13 16:27:22,016 - stpipe.Image2Pipeline - INFO - Prefetch for SFLAT reference file is 'N/A'.
2025-09-13 16:27:22,016 - stpipe.Image2Pipeline - INFO - Prefetch for SPECWCS reference file is 'N/A'.
2025-09-13 16:27:22,016 - stpipe.Image2Pipeline - INFO - Prefetch for WAVELENGTHRANGE reference file is 'N/A'.
2025-09-13 16:27:22,017 - stpipe.Image2Pipeline - INFO - Starting calwebb_image2 ...
2025-09-13 16:27:22,017 - stpipe.Image2Pipeline - INFO - Processing product /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage1/jw02079004003_04101_00002_nis
2025-09-13 16:27:22,017 - stpipe.Image2Pipeline - INFO - Working on input /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage1/jw02079004003_04101_00002_nis_rate.fits ...
2025-09-13 16:27:22,270 - stpipe.Image2Pipeline.assign_wcs - INFO - Step assign_wcs running with args (<ImageModel(2048, 2048) from /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage2_img/jw02079004003_04101_00002_nis_image2pipeline.fits>,).
2025-09-13 16:27:22,354 - jwst.assign_wcs.niriss - INFO - Offsets from filteroffset file are 2.119, -1.0476
2025-09-13 16:27:22,405 - stcal.alignment.util - INFO - Update S_REGION to POLYGON ICRS 53.145460529 -27.807804453 53.185335412 -27.795348957 53.171164480 -27.760394357 53.131324980 -27.772827778
2025-09-13 16:27:22,406 - jwst.assign_wcs.assign_wcs - INFO - assign_wcs updated S_REGION to POLYGON ICRS 53.145460529 -27.807804453 53.185335412 -27.795348957 53.171164480 -27.760394357 53.131324980 -27.772827778
2025-09-13 16:27:22,407 - jwst.assign_wcs.assign_wcs - INFO - COMPLETED assign_wcs
2025-09-13 16:27:22,453 - stpipe.Image2Pipeline.assign_wcs - INFO - Step assign_wcs done
2025-09-13 16:27:22,663 - stpipe.Image2Pipeline.flat_field - INFO - Step flat_field running with args (<ImageModel(2048, 2048) from /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage2_img/jw02079004003_04101_00002_nis_image2pipeline.fits>,).
2025-09-13 16:27:22,729 - stpipe.Image2Pipeline.flat_field - INFO - Using FLAT reference file: /home/runner/crds/references/jwst/niriss/jwst_niriss_flat_0268.fits
2025-09-13 16:27:22,729 - stpipe.Image2Pipeline.flat_field - INFO - No reference found for type FFLAT
2025-09-13 16:27:22,730 - stpipe.Image2Pipeline.flat_field - INFO - No reference found for type SFLAT
2025-09-13 16:27:22,730 - stpipe.Image2Pipeline.flat_field - INFO - No reference found for type DFLAT
2025-09-13 16:27:22,885 - stpipe.Image2Pipeline.flat_field - INFO - Step flat_field done
2025-09-13 16:27:23,099 - stpipe.Image2Pipeline.photom - INFO - Step photom running with args (<ImageModel(2048, 2048) from /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage2_img/jw02079004003_04101_00002_nis_image2pipeline.fits>,).
2025-09-13 16:27:23,111 - stpipe.Image2Pipeline.photom - INFO - Using photom reference file: /home/runner/crds/references/jwst/niriss/jwst_niriss_photom_0046.fits
2025-09-13 16:27:23,111 - stpipe.Image2Pipeline.photom - INFO - Using area reference file: /home/runner/crds/references/jwst/niriss/jwst_niriss_area_0017.fits
2025-09-13 16:27:23,146 - jwst.photom.photom - INFO - Using instrument: NIRISS
2025-09-13 16:27:23,146 - jwst.photom.photom - INFO - detector: NIS
2025-09-13 16:27:23,147 - jwst.photom.photom - INFO - exp_type: NIS_IMAGE
2025-09-13 16:27:23,147 - jwst.photom.photom - INFO - filter: CLEAR
2025-09-13 16:27:23,148 - jwst.photom.photom - INFO - pupil: F200W
2025-09-13 16:27:23,174 - jwst.photom.photom - INFO - Pixel area map copied to output.
2025-09-13 16:27:23,174 - jwst.photom.photom - INFO - Values for PIXAR_SR and PIXAR_A2 obtained from AREA reference file.
2025-09-13 16:27:23,175 - jwst.photom.photom - INFO - PHOTMJSR value: 0.258197
2025-09-13 16:27:23,227 - stpipe.Image2Pipeline.photom - INFO - Step photom done
2025-09-13 16:27:23,439 - stpipe.Image2Pipeline.resample - INFO - Step resample running with args (<ImageModel(2048, 2048) from /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage2_img/jw02079004003_04101_00002_nis_image2pipeline.fits>,).
2025-09-13 16:27:23,440 - stpipe.Image2Pipeline.resample - INFO - Step skipped.
2025-09-13 16:27:23,442 - stpipe.Image2Pipeline - INFO - Finished processing product /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage1/jw02079004003_04101_00002_nis
2025-09-13 16:27:23,442 - stpipe.Image2Pipeline - INFO - ... ending calwebb_image2
2025-09-13 16:27:23,443 - jwst.stpipe.core - INFO - Results used CRDS context: jwst_1413.pmap
2025-09-13 16:27:23,618 - stpipe.Image2Pipeline - INFO - Saved model in /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage2_img/jw02079004003_04101_00002_nis_cal.fits
2025-09-13 16:27:23,618 - stpipe.Image2Pipeline - INFO - Step Image2Pipeline done
2025-09-13 16:27:23,619 - jwst.stpipe.core - INFO - Results used jwst version: 1.19.1
2025-09-13 16:27:23,642 - stpipe - INFO - PARS-RESAMPLESTEP parameters found: /home/runner/crds/references/jwst/niriss/jwst_niriss_pars-resamplestep_0001.asdf
2025-09-13 16:27:23,650 - stpipe - INFO - PARS-IMAGE2PIPELINE parameters found: /home/runner/crds/references/jwst/niriss/jwst_niriss_pars-image2pipeline_0002.asdf
2025-09-13 16:27:23,661 - stpipe.Image2Pipeline - INFO - Image2Pipeline instance created.
2025-09-13 16:27:23,663 - stpipe.Image2Pipeline.bkg_subtract - INFO - BackgroundStep instance created.
2025-09-13 16:27:23,664 - stpipe.Image2Pipeline.assign_wcs - INFO - AssignWcsStep instance created.
2025-09-13 16:27:23,665 - stpipe.Image2Pipeline.flat_field - INFO - FlatFieldStep instance created.
2025-09-13 16:27:23,666 - stpipe.Image2Pipeline.photom - INFO - PhotomStep instance created.
2025-09-13 16:27:23,667 - stpipe.Image2Pipeline.resample - INFO - ResampleStep instance created.
2025-09-13 16:27:23,886 - stpipe.Image2Pipeline - INFO - Step Image2Pipeline running with args ('/home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage1/jw02079004003_04101_00003_nis_rate.fits',).
2025-09-13 16:27:23,894 - stpipe.Image2Pipeline - INFO - Step Image2Pipeline parameters are:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage2_img
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: True
skip: False
suffix: None
search_output_file: True
input_dir: ''
save_bsub: False
steps:
bkg_subtract:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: True
suffix: None
search_output_file: True
input_dir: ''
bkg_list: None
save_combined_background: False
sigma: 3.0
maxiters: None
soss_source_percentile: 35.0
soss_bkg_percentile: None
wfss_mmag_extract: None
wfss_maxiter: 5
wfss_rms_stop: 0.0
wfss_outlier_percent: 1.0
assign_wcs:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
sip_approx: True
sip_max_pix_error: 0.01
sip_degree: None
sip_max_inv_pix_error: 0.01
sip_inv_degree: None
sip_npoints: 12
slit_y_low: -0.55
slit_y_high: 0.55
nrs_ifu_slice_wcs: False
flat_field:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
save_interpolated_flat: False
user_supplied_flat: None
inverse: False
photom:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
inverse: False
source_type: None
mrs_time_correction: True
resample:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: True
suffix: None
search_output_file: True
input_dir: ''
pixfrac: 1.0
kernel: square
fillval: NAN
weight_type: ivm
output_shape: None
crpix: None
crval: None
rotation: None
pixel_scale_ratio: 1.0
pixel_scale: None
output_wcs: ''
single: False
blendheaders: True
in_memory: True
enable_ctx: True
enable_err: True
report_var: True
2025-09-13 16:27:23,913 - stpipe.Image2Pipeline - INFO - Prefetching reference files for dataset: 'jw02079004003_04101_00003_nis_rate.fits' reftypes = ['area', 'camera', 'collimator', 'dflat', 'disperser', 'distortion', 'fflat', 'filteroffset', 'flat', 'fore', 'fpa', 'ifufore', 'ifupost', 'ifuslicer', 'msa', 'ote', 'photom', 'regions', 'sflat', 'specwcs', 'wavelengthrange']
2025-09-13 16:27:23,916 - stpipe.Image2Pipeline - INFO - Prefetch for AREA reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_area_0017.fits'.
2025-09-13 16:27:23,917 - stpipe.Image2Pipeline - INFO - Prefetch for CAMERA reference file is 'N/A'.
2025-09-13 16:27:23,917 - stpipe.Image2Pipeline - INFO - Prefetch for COLLIMATOR reference file is 'N/A'.
2025-09-13 16:27:23,917 - stpipe.Image2Pipeline - INFO - Prefetch for DFLAT reference file is 'N/A'.
2025-09-13 16:27:23,917 - stpipe.Image2Pipeline - INFO - Prefetch for DISPERSER reference file is 'N/A'.
2025-09-13 16:27:23,918 - stpipe.Image2Pipeline - INFO - Prefetch for DISTORTION reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_distortion_0037.asdf'.
2025-09-13 16:27:23,919 - stpipe.Image2Pipeline - INFO - Prefetch for FFLAT reference file is 'N/A'.
2025-09-13 16:27:23,919 - stpipe.Image2Pipeline - INFO - Prefetch for FILTEROFFSET reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_filteroffset_0006.asdf'.
2025-09-13 16:27:23,919 - stpipe.Image2Pipeline - INFO - Prefetch for FLAT reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_flat_0268.fits'.
2025-09-13 16:27:23,920 - stpipe.Image2Pipeline - INFO - Prefetch for FORE reference file is 'N/A'.
2025-09-13 16:27:23,920 - stpipe.Image2Pipeline - INFO - Prefetch for FPA reference file is 'N/A'.
2025-09-13 16:27:23,921 - stpipe.Image2Pipeline - INFO - Prefetch for IFUFORE reference file is 'N/A'.
2025-09-13 16:27:23,921 - stpipe.Image2Pipeline - INFO - Prefetch for IFUPOST reference file is 'N/A'.
2025-09-13 16:27:23,921 - stpipe.Image2Pipeline - INFO - Prefetch for IFUSLICER reference file is 'N/A'.
2025-09-13 16:27:23,922 - stpipe.Image2Pipeline - INFO - Prefetch for MSA reference file is 'N/A'.
2025-09-13 16:27:23,922 - stpipe.Image2Pipeline - INFO - Prefetch for OTE reference file is 'N/A'.
2025-09-13 16:27:23,922 - stpipe.Image2Pipeline - INFO - Prefetch for PHOTOM reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_photom_0046.fits'.
2025-09-13 16:27:23,923 - stpipe.Image2Pipeline - INFO - Prefetch for REGIONS reference file is 'N/A'.
2025-09-13 16:27:23,923 - stpipe.Image2Pipeline - INFO - Prefetch for SFLAT reference file is 'N/A'.
2025-09-13 16:27:23,923 - stpipe.Image2Pipeline - INFO - Prefetch for SPECWCS reference file is 'N/A'.
2025-09-13 16:27:23,923 - stpipe.Image2Pipeline - INFO - Prefetch for WAVELENGTHRANGE reference file is 'N/A'.
2025-09-13 16:27:23,924 - stpipe.Image2Pipeline - INFO - Starting calwebb_image2 ...
2025-09-13 16:27:23,925 - stpipe.Image2Pipeline - INFO - Processing product /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage1/jw02079004003_04101_00003_nis
2025-09-13 16:27:23,925 - stpipe.Image2Pipeline - INFO - Working on input /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage1/jw02079004003_04101_00003_nis_rate.fits ...
2025-09-13 16:27:24,187 - stpipe.Image2Pipeline.assign_wcs - INFO - Step assign_wcs running with args (<ImageModel(2048, 2048) from /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage2_img/jw02079004003_04101_00003_nis_image2pipeline.fits>,).
2025-09-13 16:27:24,269 - jwst.assign_wcs.niriss - INFO - Offsets from filteroffset file are 2.119, -1.0476
2025-09-13 16:27:24,321 - stcal.alignment.util - INFO - Update S_REGION to POLYGON ICRS 53.145302651 -27.807767041 53.185177548 -27.795311613 53.171006697 -27.760356989 53.131167184 -27.772790342
2025-09-13 16:27:24,322 - jwst.assign_wcs.assign_wcs - INFO - assign_wcs updated S_REGION to POLYGON ICRS 53.145302651 -27.807767041 53.185177548 -27.795311613 53.171006697 -27.760356989 53.131167184 -27.772790342
2025-09-13 16:27:24,322 - jwst.assign_wcs.assign_wcs - INFO - COMPLETED assign_wcs
2025-09-13 16:27:24,367 - stpipe.Image2Pipeline.assign_wcs - INFO - Step assign_wcs done
2025-09-13 16:27:24,577 - stpipe.Image2Pipeline.flat_field - INFO - Step flat_field running with args (<ImageModel(2048, 2048) from /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage2_img/jw02079004003_04101_00003_nis_image2pipeline.fits>,).
2025-09-13 16:27:24,641 - stpipe.Image2Pipeline.flat_field - INFO - Using FLAT reference file: /home/runner/crds/references/jwst/niriss/jwst_niriss_flat_0268.fits
2025-09-13 16:27:24,642 - stpipe.Image2Pipeline.flat_field - INFO - No reference found for type FFLAT
2025-09-13 16:27:24,642 - stpipe.Image2Pipeline.flat_field - INFO - No reference found for type SFLAT
2025-09-13 16:27:24,642 - stpipe.Image2Pipeline.flat_field - INFO - No reference found for type DFLAT
2025-09-13 16:27:24,800 - stpipe.Image2Pipeline.flat_field - INFO - Step flat_field done
2025-09-13 16:27:25,011 - stpipe.Image2Pipeline.photom - INFO - Step photom running with args (<ImageModel(2048, 2048) from /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage2_img/jw02079004003_04101_00003_nis_image2pipeline.fits>,).
2025-09-13 16:27:25,022 - stpipe.Image2Pipeline.photom - INFO - Using photom reference file: /home/runner/crds/references/jwst/niriss/jwst_niriss_photom_0046.fits
2025-09-13 16:27:25,022 - stpipe.Image2Pipeline.photom - INFO - Using area reference file: /home/runner/crds/references/jwst/niriss/jwst_niriss_area_0017.fits
2025-09-13 16:27:25,056 - jwst.photom.photom - INFO - Using instrument: NIRISS
2025-09-13 16:27:25,057 - jwst.photom.photom - INFO - detector: NIS
2025-09-13 16:27:25,057 - jwst.photom.photom - INFO - exp_type: NIS_IMAGE
2025-09-13 16:27:25,057 - jwst.photom.photom - INFO - filter: CLEAR
2025-09-13 16:27:25,058 - jwst.photom.photom - INFO - pupil: F200W
2025-09-13 16:27:25,083 - jwst.photom.photom - INFO - Pixel area map copied to output.
2025-09-13 16:27:25,084 - jwst.photom.photom - INFO - Values for PIXAR_SR and PIXAR_A2 obtained from AREA reference file.
2025-09-13 16:27:25,085 - jwst.photom.photom - INFO - PHOTMJSR value: 0.258197
2025-09-13 16:27:25,136 - stpipe.Image2Pipeline.photom - INFO - Step photom done
2025-09-13 16:27:25,339 - stpipe.Image2Pipeline.resample - INFO - Step resample running with args (<ImageModel(2048, 2048) from /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage2_img/jw02079004003_04101_00003_nis_image2pipeline.fits>,).
2025-09-13 16:27:25,340 - stpipe.Image2Pipeline.resample - INFO - Step skipped.
2025-09-13 16:27:25,342 - stpipe.Image2Pipeline - INFO - Finished processing product /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage1/jw02079004003_04101_00003_nis
2025-09-13 16:27:25,342 - stpipe.Image2Pipeline - INFO - ... ending calwebb_image2
2025-09-13 16:27:25,343 - jwst.stpipe.core - INFO - Results used CRDS context: jwst_1413.pmap
2025-09-13 16:27:25,517 - stpipe.Image2Pipeline - INFO - Saved model in /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage2_img/jw02079004003_04101_00003_nis_cal.fits
2025-09-13 16:27:25,517 - stpipe.Image2Pipeline - INFO - Step Image2Pipeline done
2025-09-13 16:27:25,518 - jwst.stpipe.core - INFO - Results used jwst version: 1.19.1
2025-09-13 16:27:25,540 - stpipe - INFO - PARS-RESAMPLESTEP parameters found: /home/runner/crds/references/jwst/niriss/jwst_niriss_pars-resamplestep_0001.asdf
2025-09-13 16:27:25,548 - stpipe - INFO - PARS-IMAGE2PIPELINE parameters found: /home/runner/crds/references/jwst/niriss/jwst_niriss_pars-image2pipeline_0002.asdf
2025-09-13 16:27:25,558 - stpipe.Image2Pipeline - INFO - Image2Pipeline instance created.
2025-09-13 16:27:25,559 - stpipe.Image2Pipeline.bkg_subtract - INFO - BackgroundStep instance created.
2025-09-13 16:27:25,561 - stpipe.Image2Pipeline.assign_wcs - INFO - AssignWcsStep instance created.
2025-09-13 16:27:25,561 - stpipe.Image2Pipeline.flat_field - INFO - FlatFieldStep instance created.
2025-09-13 16:27:25,562 - stpipe.Image2Pipeline.photom - INFO - PhotomStep instance created.
2025-09-13 16:27:25,563 - stpipe.Image2Pipeline.resample - INFO - ResampleStep instance created.
2025-09-13 16:27:25,768 - stpipe.Image2Pipeline - INFO - Step Image2Pipeline running with args ('/home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage1/jw02079004003_04101_00004_nis_rate.fits',).
2025-09-13 16:27:25,776 - stpipe.Image2Pipeline - INFO - Step Image2Pipeline parameters are:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage2_img
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: True
skip: False
suffix: None
search_output_file: True
input_dir: ''
save_bsub: False
steps:
bkg_subtract:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: True
suffix: None
search_output_file: True
input_dir: ''
bkg_list: None
save_combined_background: False
sigma: 3.0
maxiters: None
soss_source_percentile: 35.0
soss_bkg_percentile: None
wfss_mmag_extract: None
wfss_maxiter: 5
wfss_rms_stop: 0.0
wfss_outlier_percent: 1.0
assign_wcs:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
sip_approx: True
sip_max_pix_error: 0.01
sip_degree: None
sip_max_inv_pix_error: 0.01
sip_inv_degree: None
sip_npoints: 12
slit_y_low: -0.55
slit_y_high: 0.55
nrs_ifu_slice_wcs: False
flat_field:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
save_interpolated_flat: False
user_supplied_flat: None
inverse: False
photom:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
inverse: False
source_type: None
mrs_time_correction: True
resample:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: True
suffix: None
search_output_file: True
input_dir: ''
pixfrac: 1.0
kernel: square
fillval: NAN
weight_type: ivm
output_shape: None
crpix: None
crval: None
rotation: None
pixel_scale_ratio: 1.0
pixel_scale: None
output_wcs: ''
single: False
blendheaders: True
in_memory: True
enable_ctx: True
enable_err: True
report_var: True
2025-09-13 16:27:25,794 - stpipe.Image2Pipeline - INFO - Prefetching reference files for dataset: 'jw02079004003_04101_00004_nis_rate.fits' reftypes = ['area', 'camera', 'collimator', 'dflat', 'disperser', 'distortion', 'fflat', 'filteroffset', 'flat', 'fore', 'fpa', 'ifufore', 'ifupost', 'ifuslicer', 'msa', 'ote', 'photom', 'regions', 'sflat', 'specwcs', 'wavelengthrange']
2025-09-13 16:27:25,797 - stpipe.Image2Pipeline - INFO - Prefetch for AREA reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_area_0017.fits'.
2025-09-13 16:27:25,797 - stpipe.Image2Pipeline - INFO - Prefetch for CAMERA reference file is 'N/A'.
2025-09-13 16:27:25,798 - stpipe.Image2Pipeline - INFO - Prefetch for COLLIMATOR reference file is 'N/A'.
2025-09-13 16:27:25,798 - stpipe.Image2Pipeline - INFO - Prefetch for DFLAT reference file is 'N/A'.
2025-09-13 16:27:25,798 - stpipe.Image2Pipeline - INFO - Prefetch for DISPERSER reference file is 'N/A'.
2025-09-13 16:27:25,799 - stpipe.Image2Pipeline - INFO - Prefetch for DISTORTION reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_distortion_0037.asdf'.
2025-09-13 16:27:25,799 - stpipe.Image2Pipeline - INFO - Prefetch for FFLAT reference file is 'N/A'.
2025-09-13 16:27:25,799 - stpipe.Image2Pipeline - INFO - Prefetch for FILTEROFFSET reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_filteroffset_0006.asdf'.
2025-09-13 16:27:25,800 - stpipe.Image2Pipeline - INFO - Prefetch for FLAT reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_flat_0268.fits'.
2025-09-13 16:27:25,801 - stpipe.Image2Pipeline - INFO - Prefetch for FORE reference file is 'N/A'.
2025-09-13 16:27:25,801 - stpipe.Image2Pipeline - INFO - Prefetch for FPA reference file is 'N/A'.
2025-09-13 16:27:25,801 - stpipe.Image2Pipeline - INFO - Prefetch for IFUFORE reference file is 'N/A'.
2025-09-13 16:27:25,802 - stpipe.Image2Pipeline - INFO - Prefetch for IFUPOST reference file is 'N/A'.
2025-09-13 16:27:25,802 - stpipe.Image2Pipeline - INFO - Prefetch for IFUSLICER reference file is 'N/A'.
2025-09-13 16:27:25,803 - stpipe.Image2Pipeline - INFO - Prefetch for MSA reference file is 'N/A'.
2025-09-13 16:27:25,803 - stpipe.Image2Pipeline - INFO - Prefetch for OTE reference file is 'N/A'.
2025-09-13 16:27:25,803 - stpipe.Image2Pipeline - INFO - Prefetch for PHOTOM reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_photom_0046.fits'.
2025-09-13 16:27:25,804 - stpipe.Image2Pipeline - INFO - Prefetch for REGIONS reference file is 'N/A'.
2025-09-13 16:27:25,804 - stpipe.Image2Pipeline - INFO - Prefetch for SFLAT reference file is 'N/A'.
2025-09-13 16:27:25,804 - stpipe.Image2Pipeline - INFO - Prefetch for SPECWCS reference file is 'N/A'.
2025-09-13 16:27:25,805 - stpipe.Image2Pipeline - INFO - Prefetch for WAVELENGTHRANGE reference file is 'N/A'.
2025-09-13 16:27:25,805 - stpipe.Image2Pipeline - INFO - Starting calwebb_image2 ...
2025-09-13 16:27:25,806 - stpipe.Image2Pipeline - INFO - Processing product /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage1/jw02079004003_04101_00004_nis
2025-09-13 16:27:25,806 - stpipe.Image2Pipeline - INFO - Working on input /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage1/jw02079004003_04101_00004_nis_rate.fits ...
2025-09-13 16:27:26,052 - stpipe.Image2Pipeline.assign_wcs - INFO - Step assign_wcs running with args (<ImageModel(2048, 2048) from /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage2_img/jw02079004003_04101_00004_nis_image2pipeline.fits>,).
2025-09-13 16:27:26,134 - jwst.assign_wcs.niriss - INFO - Offsets from filteroffset file are 2.119, -1.0476
2025-09-13 16:27:26,185 - stcal.alignment.util - INFO - Update S_REGION to POLYGON ICRS 53.149034210 -27.809553310 53.188909305 -27.797096736 53.174736939 -27.762142520 53.134897228 -27.774577017
2025-09-13 16:27:26,186 - jwst.assign_wcs.assign_wcs - INFO - assign_wcs updated S_REGION to POLYGON ICRS 53.149034210 -27.809553310 53.188909305 -27.797096736 53.174736939 -27.762142520 53.134897228 -27.774577017
2025-09-13 16:27:26,186 - jwst.assign_wcs.assign_wcs - INFO - COMPLETED assign_wcs
2025-09-13 16:27:26,231 - stpipe.Image2Pipeline.assign_wcs - INFO - Step assign_wcs done
2025-09-13 16:27:26,438 - stpipe.Image2Pipeline.flat_field - INFO - Step flat_field running with args (<ImageModel(2048, 2048) from /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage2_img/jw02079004003_04101_00004_nis_image2pipeline.fits>,).
2025-09-13 16:27:26,504 - stpipe.Image2Pipeline.flat_field - INFO - Using FLAT reference file: /home/runner/crds/references/jwst/niriss/jwst_niriss_flat_0268.fits
2025-09-13 16:27:26,504 - stpipe.Image2Pipeline.flat_field - INFO - No reference found for type FFLAT
2025-09-13 16:27:26,505 - stpipe.Image2Pipeline.flat_field - INFO - No reference found for type SFLAT
2025-09-13 16:27:26,505 - stpipe.Image2Pipeline.flat_field - INFO - No reference found for type DFLAT
2025-09-13 16:27:26,658 - stpipe.Image2Pipeline.flat_field - INFO - Step flat_field done
2025-09-13 16:27:26,869 - stpipe.Image2Pipeline.photom - INFO - Step photom running with args (<ImageModel(2048, 2048) from /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage2_img/jw02079004003_04101_00004_nis_image2pipeline.fits>,).
2025-09-13 16:27:26,881 - stpipe.Image2Pipeline.photom - INFO - Using photom reference file: /home/runner/crds/references/jwst/niriss/jwst_niriss_photom_0046.fits
2025-09-13 16:27:26,881 - stpipe.Image2Pipeline.photom - INFO - Using area reference file: /home/runner/crds/references/jwst/niriss/jwst_niriss_area_0017.fits
2025-09-13 16:27:26,915 - jwst.photom.photom - INFO - Using instrument: NIRISS
2025-09-13 16:27:26,916 - jwst.photom.photom - INFO - detector: NIS
2025-09-13 16:27:26,916 - jwst.photom.photom - INFO - exp_type: NIS_IMAGE
2025-09-13 16:27:26,916 - jwst.photom.photom - INFO - filter: CLEAR
2025-09-13 16:27:26,917 - jwst.photom.photom - INFO - pupil: F200W
2025-09-13 16:27:26,942 - jwst.photom.photom - INFO - Pixel area map copied to output.
2025-09-13 16:27:26,943 - jwst.photom.photom - INFO - Values for PIXAR_SR and PIXAR_A2 obtained from AREA reference file.
2025-09-13 16:27:26,944 - jwst.photom.photom - INFO - PHOTMJSR value: 0.258197
2025-09-13 16:27:26,995 - stpipe.Image2Pipeline.photom - INFO - Step photom done
2025-09-13 16:27:27,211 - stpipe.Image2Pipeline.resample - INFO - Step resample running with args (<ImageModel(2048, 2048) from /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage2_img/jw02079004003_04101_00004_nis_image2pipeline.fits>,).
2025-09-13 16:27:27,212 - stpipe.Image2Pipeline.resample - INFO - Step skipped.
2025-09-13 16:27:27,213 - stpipe.Image2Pipeline - INFO - Finished processing product /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage1/jw02079004003_04101_00004_nis
2025-09-13 16:27:27,214 - stpipe.Image2Pipeline - INFO - ... ending calwebb_image2
2025-09-13 16:27:27,214 - jwst.stpipe.core - INFO - Results used CRDS context: jwst_1413.pmap
2025-09-13 16:27:27,386 - stpipe.Image2Pipeline - INFO - Saved model in /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage2_img/jw02079004003_04101_00004_nis_cal.fits
2025-09-13 16:27:27,387 - stpipe.Image2Pipeline - INFO - Step Image2Pipeline done
2025-09-13 16:27:27,387 - jwst.stpipe.core - INFO - Results used jwst version: 1.19.1
2025-09-13 16:27:27,410 - stpipe - INFO - PARS-RESAMPLESTEP parameters found: /home/runner/crds/references/jwst/niriss/jwst_niriss_pars-resamplestep_0001.asdf
2025-09-13 16:27:27,418 - stpipe - INFO - PARS-IMAGE2PIPELINE parameters found: /home/runner/crds/references/jwst/niriss/jwst_niriss_pars-image2pipeline_0002.asdf
2025-09-13 16:27:27,428 - stpipe.Image2Pipeline - INFO - Image2Pipeline instance created.
2025-09-13 16:27:27,429 - stpipe.Image2Pipeline.bkg_subtract - INFO - BackgroundStep instance created.
2025-09-13 16:27:27,430 - stpipe.Image2Pipeline.assign_wcs - INFO - AssignWcsStep instance created.
2025-09-13 16:27:27,431 - stpipe.Image2Pipeline.flat_field - INFO - FlatFieldStep instance created.
2025-09-13 16:27:27,432 - stpipe.Image2Pipeline.photom - INFO - PhotomStep instance created.
2025-09-13 16:27:27,433 - stpipe.Image2Pipeline.resample - INFO - ResampleStep instance created.
2025-09-13 16:27:27,636 - stpipe.Image2Pipeline - INFO - Step Image2Pipeline running with args ('/home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage1/jw02079004003_06101_00001_nis_rate.fits',).
2025-09-13 16:27:27,644 - stpipe.Image2Pipeline - INFO - Step Image2Pipeline parameters are:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage2_img
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: True
skip: False
suffix: None
search_output_file: True
input_dir: ''
save_bsub: False
steps:
bkg_subtract:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: True
suffix: None
search_output_file: True
input_dir: ''
bkg_list: None
save_combined_background: False
sigma: 3.0
maxiters: None
soss_source_percentile: 35.0
soss_bkg_percentile: None
wfss_mmag_extract: None
wfss_maxiter: 5
wfss_rms_stop: 0.0
wfss_outlier_percent: 1.0
assign_wcs:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
sip_approx: True
sip_max_pix_error: 0.01
sip_degree: None
sip_max_inv_pix_error: 0.01
sip_inv_degree: None
sip_npoints: 12
slit_y_low: -0.55
slit_y_high: 0.55
nrs_ifu_slice_wcs: False
flat_field:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
save_interpolated_flat: False
user_supplied_flat: None
inverse: False
photom:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
inverse: False
source_type: None
mrs_time_correction: True
resample:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: True
suffix: None
search_output_file: True
input_dir: ''
pixfrac: 1.0
kernel: square
fillval: NAN
weight_type: ivm
output_shape: None
crpix: None
crval: None
rotation: None
pixel_scale_ratio: 1.0
pixel_scale: None
output_wcs: ''
single: False
blendheaders: True
in_memory: True
enable_ctx: True
enable_err: True
report_var: True
2025-09-13 16:27:27,662 - stpipe.Image2Pipeline - INFO - Prefetching reference files for dataset: 'jw02079004003_06101_00001_nis_rate.fits' reftypes = ['area', 'camera', 'collimator', 'dflat', 'disperser', 'distortion', 'fflat', 'filteroffset', 'flat', 'fore', 'fpa', 'ifufore', 'ifupost', 'ifuslicer', 'msa', 'ote', 'photom', 'regions', 'sflat', 'specwcs', 'wavelengthrange']
2025-09-13 16:27:27,665 - stpipe.Image2Pipeline - INFO - Prefetch for AREA reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_area_0017.fits'.
2025-09-13 16:27:27,665 - stpipe.Image2Pipeline - INFO - Prefetch for CAMERA reference file is 'N/A'.
2025-09-13 16:27:27,666 - stpipe.Image2Pipeline - INFO - Prefetch for COLLIMATOR reference file is 'N/A'.
2025-09-13 16:27:27,666 - stpipe.Image2Pipeline - INFO - Prefetch for DFLAT reference file is 'N/A'.
2025-09-13 16:27:27,666 - stpipe.Image2Pipeline - INFO - Prefetch for DISPERSER reference file is 'N/A'.
2025-09-13 16:27:27,666 - stpipe.Image2Pipeline - INFO - Prefetch for DISTORTION reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_distortion_0037.asdf'.
2025-09-13 16:27:27,667 - stpipe.Image2Pipeline - INFO - Prefetch for FFLAT reference file is 'N/A'.
2025-09-13 16:27:27,667 - stpipe.Image2Pipeline - INFO - Prefetch for FILTEROFFSET reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_filteroffset_0006.asdf'.
2025-09-13 16:27:27,668 - stpipe.Image2Pipeline - INFO - Prefetch for FLAT reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_flat_0268.fits'.
2025-09-13 16:27:27,668 - stpipe.Image2Pipeline - INFO - Prefetch for FORE reference file is 'N/A'.
2025-09-13 16:27:27,668 - stpipe.Image2Pipeline - INFO - Prefetch for FPA reference file is 'N/A'.
2025-09-13 16:27:27,669 - stpipe.Image2Pipeline - INFO - Prefetch for IFUFORE reference file is 'N/A'.
2025-09-13 16:27:27,669 - stpipe.Image2Pipeline - INFO - Prefetch for IFUPOST reference file is 'N/A'.
2025-09-13 16:27:27,669 - stpipe.Image2Pipeline - INFO - Prefetch for IFUSLICER reference file is 'N/A'.
2025-09-13 16:27:27,669 - stpipe.Image2Pipeline - INFO - Prefetch for MSA reference file is 'N/A'.
2025-09-13 16:27:27,670 - stpipe.Image2Pipeline - INFO - Prefetch for OTE reference file is 'N/A'.
2025-09-13 16:27:27,670 - stpipe.Image2Pipeline - INFO - Prefetch for PHOTOM reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_photom_0046.fits'.
2025-09-13 16:27:27,670 - stpipe.Image2Pipeline - INFO - Prefetch for REGIONS reference file is 'N/A'.
2025-09-13 16:27:27,671 - stpipe.Image2Pipeline - INFO - Prefetch for SFLAT reference file is 'N/A'.
2025-09-13 16:27:27,671 - stpipe.Image2Pipeline - INFO - Prefetch for SPECWCS reference file is 'N/A'.
2025-09-13 16:27:27,671 - stpipe.Image2Pipeline - INFO - Prefetch for WAVELENGTHRANGE reference file is 'N/A'.
2025-09-13 16:27:27,671 - stpipe.Image2Pipeline - INFO - Starting calwebb_image2 ...
2025-09-13 16:27:27,672 - stpipe.Image2Pipeline - INFO - Processing product /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage1/jw02079004003_06101_00001_nis
2025-09-13 16:27:27,672 - stpipe.Image2Pipeline - INFO - Working on input /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage1/jw02079004003_06101_00001_nis_rate.fits ...
2025-09-13 16:27:27,925 - stpipe.Image2Pipeline.assign_wcs - INFO - Step assign_wcs running with args (<ImageModel(2048, 2048) from /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage2_img/jw02079004003_06101_00001_nis_image2pipeline.fits>,).
2025-09-13 16:27:28,007 - jwst.assign_wcs.niriss - INFO - Offsets from filteroffset file are 2.119, -1.0476
2025-09-13 16:27:28,058 - stcal.alignment.util - INFO - Update S_REGION to POLYGON ICRS 53.149317923 -27.809298180 53.189192904 -27.796841555 53.175020513 -27.761887357 53.135180916 -27.774321906
2025-09-13 16:27:28,059 - jwst.assign_wcs.assign_wcs - INFO - assign_wcs updated S_REGION to POLYGON ICRS 53.149317923 -27.809298180 53.189192904 -27.796841555 53.175020513 -27.761887357 53.135180916 -27.774321906
2025-09-13 16:27:28,059 - jwst.assign_wcs.assign_wcs - INFO - COMPLETED assign_wcs
2025-09-13 16:27:28,104 - stpipe.Image2Pipeline.assign_wcs - INFO - Step assign_wcs done
2025-09-13 16:27:28,314 - stpipe.Image2Pipeline.flat_field - INFO - Step flat_field running with args (<ImageModel(2048, 2048) from /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage2_img/jw02079004003_06101_00001_nis_image2pipeline.fits>,).
2025-09-13 16:27:28,379 - stpipe.Image2Pipeline.flat_field - INFO - Using FLAT reference file: /home/runner/crds/references/jwst/niriss/jwst_niriss_flat_0268.fits
2025-09-13 16:27:28,380 - stpipe.Image2Pipeline.flat_field - INFO - No reference found for type FFLAT
2025-09-13 16:27:28,380 - stpipe.Image2Pipeline.flat_field - INFO - No reference found for type SFLAT
2025-09-13 16:27:28,380 - stpipe.Image2Pipeline.flat_field - INFO - No reference found for type DFLAT
2025-09-13 16:27:28,539 - stpipe.Image2Pipeline.flat_field - INFO - Step flat_field done
2025-09-13 16:27:28,752 - stpipe.Image2Pipeline.photom - INFO - Step photom running with args (<ImageModel(2048, 2048) from /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage2_img/jw02079004003_06101_00001_nis_image2pipeline.fits>,).
2025-09-13 16:27:28,763 - stpipe.Image2Pipeline.photom - INFO - Using photom reference file: /home/runner/crds/references/jwst/niriss/jwst_niriss_photom_0046.fits
2025-09-13 16:27:28,764 - stpipe.Image2Pipeline.photom - INFO - Using area reference file: /home/runner/crds/references/jwst/niriss/jwst_niriss_area_0017.fits
2025-09-13 16:27:28,798 - jwst.photom.photom - INFO - Using instrument: NIRISS
2025-09-13 16:27:28,799 - jwst.photom.photom - INFO - detector: NIS
2025-09-13 16:27:28,799 - jwst.photom.photom - INFO - exp_type: NIS_IMAGE
2025-09-13 16:27:28,800 - jwst.photom.photom - INFO - filter: CLEAR
2025-09-13 16:27:28,800 - jwst.photom.photom - INFO - pupil: F200W
2025-09-13 16:27:28,825 - jwst.photom.photom - INFO - Pixel area map copied to output.
2025-09-13 16:27:28,826 - jwst.photom.photom - INFO - Values for PIXAR_SR and PIXAR_A2 obtained from AREA reference file.
2025-09-13 16:27:28,827 - jwst.photom.photom - INFO - PHOTMJSR value: 0.258197
2025-09-13 16:27:28,878 - stpipe.Image2Pipeline.photom - INFO - Step photom done
2025-09-13 16:27:29,091 - stpipe.Image2Pipeline.resample - INFO - Step resample running with args (<ImageModel(2048, 2048) from /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage2_img/jw02079004003_06101_00001_nis_image2pipeline.fits>,).
2025-09-13 16:27:29,092 - stpipe.Image2Pipeline.resample - INFO - Step skipped.
2025-09-13 16:27:29,094 - stpipe.Image2Pipeline - INFO - Finished processing product /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage1/jw02079004003_06101_00001_nis
2025-09-13 16:27:29,094 - stpipe.Image2Pipeline - INFO - ... ending calwebb_image2
2025-09-13 16:27:29,095 - jwst.stpipe.core - INFO - Results used CRDS context: jwst_1413.pmap
2025-09-13 16:27:29,270 - stpipe.Image2Pipeline - INFO - Saved model in /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage2_img/jw02079004003_06101_00001_nis_cal.fits
2025-09-13 16:27:29,270 - stpipe.Image2Pipeline - INFO - Step Image2Pipeline done
2025-09-13 16:27:29,271 - jwst.stpipe.core - INFO - Results used jwst version: 1.19.1
2025-09-13 16:27:29,293 - stpipe - INFO - PARS-RESAMPLESTEP parameters found: /home/runner/crds/references/jwst/niriss/jwst_niriss_pars-resamplestep_0001.asdf
2025-09-13 16:27:29,301 - stpipe - INFO - PARS-IMAGE2PIPELINE parameters found: /home/runner/crds/references/jwst/niriss/jwst_niriss_pars-image2pipeline_0002.asdf
2025-09-13 16:27:29,312 - stpipe.Image2Pipeline - INFO - Image2Pipeline instance created.
2025-09-13 16:27:29,313 - stpipe.Image2Pipeline.bkg_subtract - INFO - BackgroundStep instance created.
2025-09-13 16:27:29,314 - stpipe.Image2Pipeline.assign_wcs - INFO - AssignWcsStep instance created.
2025-09-13 16:27:29,315 - stpipe.Image2Pipeline.flat_field - INFO - FlatFieldStep instance created.
2025-09-13 16:27:29,315 - stpipe.Image2Pipeline.photom - INFO - PhotomStep instance created.
2025-09-13 16:27:29,317 - stpipe.Image2Pipeline.resample - INFO - ResampleStep instance created.
2025-09-13 16:27:29,536 - stpipe.Image2Pipeline - INFO - Step Image2Pipeline running with args ('/home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage1/jw02079004003_06101_00002_nis_rate.fits',).
2025-09-13 16:27:29,543 - stpipe.Image2Pipeline - INFO - Step Image2Pipeline parameters are:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage2_img
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: True
skip: False
suffix: None
search_output_file: True
input_dir: ''
save_bsub: False
steps:
bkg_subtract:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: True
suffix: None
search_output_file: True
input_dir: ''
bkg_list: None
save_combined_background: False
sigma: 3.0
maxiters: None
soss_source_percentile: 35.0
soss_bkg_percentile: None
wfss_mmag_extract: None
wfss_maxiter: 5
wfss_rms_stop: 0.0
wfss_outlier_percent: 1.0
assign_wcs:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
sip_approx: True
sip_max_pix_error: 0.01
sip_degree: None
sip_max_inv_pix_error: 0.01
sip_inv_degree: None
sip_npoints: 12
slit_y_low: -0.55
slit_y_high: 0.55
nrs_ifu_slice_wcs: False
flat_field:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
save_interpolated_flat: False
user_supplied_flat: None
inverse: False
photom:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
inverse: False
source_type: None
mrs_time_correction: True
resample:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: True
suffix: None
search_output_file: True
input_dir: ''
pixfrac: 1.0
kernel: square
fillval: NAN
weight_type: ivm
output_shape: None
crpix: None
crval: None
rotation: None
pixel_scale_ratio: 1.0
pixel_scale: None
output_wcs: ''
single: False
blendheaders: True
in_memory: True
enable_ctx: True
enable_err: True
report_var: True
2025-09-13 16:27:29,563 - stpipe.Image2Pipeline - INFO - Prefetching reference files for dataset: 'jw02079004003_06101_00002_nis_rate.fits' reftypes = ['area', 'camera', 'collimator', 'dflat', 'disperser', 'distortion', 'fflat', 'filteroffset', 'flat', 'fore', 'fpa', 'ifufore', 'ifupost', 'ifuslicer', 'msa', 'ote', 'photom', 'regions', 'sflat', 'specwcs', 'wavelengthrange']
2025-09-13 16:27:29,566 - stpipe.Image2Pipeline - INFO - Prefetch for AREA reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_area_0017.fits'.
2025-09-13 16:27:29,566 - stpipe.Image2Pipeline - INFO - Prefetch for CAMERA reference file is 'N/A'.
2025-09-13 16:27:29,566 - stpipe.Image2Pipeline - INFO - Prefetch for COLLIMATOR reference file is 'N/A'.
2025-09-13 16:27:29,567 - stpipe.Image2Pipeline - INFO - Prefetch for DFLAT reference file is 'N/A'.
2025-09-13 16:27:29,567 - stpipe.Image2Pipeline - INFO - Prefetch for DISPERSER reference file is 'N/A'.
2025-09-13 16:27:29,567 - stpipe.Image2Pipeline - INFO - Prefetch for DISTORTION reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_distortion_0037.asdf'.
2025-09-13 16:27:29,568 - stpipe.Image2Pipeline - INFO - Prefetch for FFLAT reference file is 'N/A'.
2025-09-13 16:27:29,568 - stpipe.Image2Pipeline - INFO - Prefetch for FILTEROFFSET reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_filteroffset_0006.asdf'.
2025-09-13 16:27:29,568 - stpipe.Image2Pipeline - INFO - Prefetch for FLAT reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_flat_0268.fits'.
2025-09-13 16:27:29,569 - stpipe.Image2Pipeline - INFO - Prefetch for FORE reference file is 'N/A'.
2025-09-13 16:27:29,569 - stpipe.Image2Pipeline - INFO - Prefetch for FPA reference file is 'N/A'.
2025-09-13 16:27:29,569 - stpipe.Image2Pipeline - INFO - Prefetch for IFUFORE reference file is 'N/A'.
2025-09-13 16:27:29,570 - stpipe.Image2Pipeline - INFO - Prefetch for IFUPOST reference file is 'N/A'.
2025-09-13 16:27:29,570 - stpipe.Image2Pipeline - INFO - Prefetch for IFUSLICER reference file is 'N/A'.
2025-09-13 16:27:29,570 - stpipe.Image2Pipeline - INFO - Prefetch for MSA reference file is 'N/A'.
2025-09-13 16:27:29,571 - stpipe.Image2Pipeline - INFO - Prefetch for OTE reference file is 'N/A'.
2025-09-13 16:27:29,571 - stpipe.Image2Pipeline - INFO - Prefetch for PHOTOM reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_photom_0046.fits'.
2025-09-13 16:27:29,572 - stpipe.Image2Pipeline - INFO - Prefetch for REGIONS reference file is 'N/A'.
2025-09-13 16:27:29,572 - stpipe.Image2Pipeline - INFO - Prefetch for SFLAT reference file is 'N/A'.
2025-09-13 16:27:29,572 - stpipe.Image2Pipeline - INFO - Prefetch for SPECWCS reference file is 'N/A'.
2025-09-13 16:27:29,573 - stpipe.Image2Pipeline - INFO - Prefetch for WAVELENGTHRANGE reference file is 'N/A'.
2025-09-13 16:27:29,573 - stpipe.Image2Pipeline - INFO - Starting calwebb_image2 ...
2025-09-13 16:27:29,573 - stpipe.Image2Pipeline - INFO - Processing product /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage1/jw02079004003_06101_00002_nis
2025-09-13 16:27:29,574 - stpipe.Image2Pipeline - INFO - Working on input /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage1/jw02079004003_06101_00002_nis_rate.fits ...
2025-09-13 16:27:29,831 - stpipe.Image2Pipeline.assign_wcs - INFO - Step assign_wcs running with args (<ImageModel(2048, 2048) from /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage2_img/jw02079004003_06101_00002_nis_image2pipeline.fits>,).
2025-09-13 16:27:29,915 - jwst.assign_wcs.niriss - INFO - Offsets from filteroffset file are 2.119, -1.0476
2025-09-13 16:27:29,967 - stcal.alignment.util - INFO - Update S_REGION to POLYGON ICRS 53.149455955 -27.809475981 53.189330997 -27.797019347 53.175158573 -27.762065152 53.135318915 -27.774499710
2025-09-13 16:27:29,968 - jwst.assign_wcs.assign_wcs - INFO - assign_wcs updated S_REGION to POLYGON ICRS 53.149455955 -27.809475981 53.189330997 -27.797019347 53.175158573 -27.762065152 53.135318915 -27.774499710
2025-09-13 16:27:29,968 - jwst.assign_wcs.assign_wcs - INFO - COMPLETED assign_wcs
2025-09-13 16:27:30,013 - stpipe.Image2Pipeline.assign_wcs - INFO - Step assign_wcs done
2025-09-13 16:27:30,226 - stpipe.Image2Pipeline.flat_field - INFO - Step flat_field running with args (<ImageModel(2048, 2048) from /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage2_img/jw02079004003_06101_00002_nis_image2pipeline.fits>,).
2025-09-13 16:27:30,292 - stpipe.Image2Pipeline.flat_field - INFO - Using FLAT reference file: /home/runner/crds/references/jwst/niriss/jwst_niriss_flat_0268.fits
2025-09-13 16:27:30,293 - stpipe.Image2Pipeline.flat_field - INFO - No reference found for type FFLAT
2025-09-13 16:27:30,293 - stpipe.Image2Pipeline.flat_field - INFO - No reference found for type SFLAT
2025-09-13 16:27:30,294 - stpipe.Image2Pipeline.flat_field - INFO - No reference found for type DFLAT
2025-09-13 16:27:30,448 - stpipe.Image2Pipeline.flat_field - INFO - Step flat_field done
2025-09-13 16:27:30,662 - stpipe.Image2Pipeline.photom - INFO - Step photom running with args (<ImageModel(2048, 2048) from /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage2_img/jw02079004003_06101_00002_nis_image2pipeline.fits>,).
2025-09-13 16:27:30,674 - stpipe.Image2Pipeline.photom - INFO - Using photom reference file: /home/runner/crds/references/jwst/niriss/jwst_niriss_photom_0046.fits
2025-09-13 16:27:30,674 - stpipe.Image2Pipeline.photom - INFO - Using area reference file: /home/runner/crds/references/jwst/niriss/jwst_niriss_area_0017.fits
2025-09-13 16:27:30,709 - jwst.photom.photom - INFO - Using instrument: NIRISS
2025-09-13 16:27:30,710 - jwst.photom.photom - INFO - detector: NIS
2025-09-13 16:27:30,710 - jwst.photom.photom - INFO - exp_type: NIS_IMAGE
2025-09-13 16:27:30,710 - jwst.photom.photom - INFO - filter: CLEAR
2025-09-13 16:27:30,711 - jwst.photom.photom - INFO - pupil: F200W
2025-09-13 16:27:30,736 - jwst.photom.photom - INFO - Pixel area map copied to output.
2025-09-13 16:27:30,736 - jwst.photom.photom - INFO - Values for PIXAR_SR and PIXAR_A2 obtained from AREA reference file.
2025-09-13 16:27:30,737 - jwst.photom.photom - INFO - PHOTMJSR value: 0.258197
2025-09-13 16:27:30,790 - stpipe.Image2Pipeline.photom - INFO - Step photom done
2025-09-13 16:27:31,009 - stpipe.Image2Pipeline.resample - INFO - Step resample running with args (<ImageModel(2048, 2048) from /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage2_img/jw02079004003_06101_00002_nis_image2pipeline.fits>,).
2025-09-13 16:27:31,010 - stpipe.Image2Pipeline.resample - INFO - Step skipped.
2025-09-13 16:27:31,011 - stpipe.Image2Pipeline - INFO - Finished processing product /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage1/jw02079004003_06101_00002_nis
2025-09-13 16:27:31,012 - stpipe.Image2Pipeline - INFO - ... ending calwebb_image2
2025-09-13 16:27:31,012 - jwst.stpipe.core - INFO - Results used CRDS context: jwst_1413.pmap
2025-09-13 16:27:31,186 - stpipe.Image2Pipeline - INFO - Saved model in /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage2_img/jw02079004003_06101_00002_nis_cal.fits
2025-09-13 16:27:31,187 - stpipe.Image2Pipeline - INFO - Step Image2Pipeline done
2025-09-13 16:27:31,187 - jwst.stpipe.core - INFO - Results used jwst version: 1.19.1
2025-09-13 16:27:31,211 - stpipe - INFO - PARS-RESAMPLESTEP parameters found: /home/runner/crds/references/jwst/niriss/jwst_niriss_pars-resamplestep_0001.asdf
2025-09-13 16:27:31,219 - stpipe - INFO - PARS-IMAGE2PIPELINE parameters found: /home/runner/crds/references/jwst/niriss/jwst_niriss_pars-image2pipeline_0002.asdf
2025-09-13 16:27:31,229 - stpipe.Image2Pipeline - INFO - Image2Pipeline instance created.
2025-09-13 16:27:31,231 - stpipe.Image2Pipeline.bkg_subtract - INFO - BackgroundStep instance created.
2025-09-13 16:27:31,232 - stpipe.Image2Pipeline.assign_wcs - INFO - AssignWcsStep instance created.
2025-09-13 16:27:31,232 - stpipe.Image2Pipeline.flat_field - INFO - FlatFieldStep instance created.
2025-09-13 16:27:31,233 - stpipe.Image2Pipeline.photom - INFO - PhotomStep instance created.
2025-09-13 16:27:31,234 - stpipe.Image2Pipeline.resample - INFO - ResampleStep instance created.
2025-09-13 16:27:31,450 - stpipe.Image2Pipeline - INFO - Step Image2Pipeline running with args ('/home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage1/jw02079004003_06101_00003_nis_rate.fits',).
2025-09-13 16:27:31,458 - stpipe.Image2Pipeline - INFO - Step Image2Pipeline parameters are:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage2_img
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: True
skip: False
suffix: None
search_output_file: True
input_dir: ''
save_bsub: False
steps:
bkg_subtract:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: True
suffix: None
search_output_file: True
input_dir: ''
bkg_list: None
save_combined_background: False
sigma: 3.0
maxiters: None
soss_source_percentile: 35.0
soss_bkg_percentile: None
wfss_mmag_extract: None
wfss_maxiter: 5
wfss_rms_stop: 0.0
wfss_outlier_percent: 1.0
assign_wcs:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
sip_approx: True
sip_max_pix_error: 0.01
sip_degree: None
sip_max_inv_pix_error: 0.01
sip_inv_degree: None
sip_npoints: 12
slit_y_low: -0.55
slit_y_high: 0.55
nrs_ifu_slice_wcs: False
flat_field:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
save_interpolated_flat: False
user_supplied_flat: None
inverse: False
photom:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
inverse: False
source_type: None
mrs_time_correction: True
resample:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: True
suffix: None
search_output_file: True
input_dir: ''
pixfrac: 1.0
kernel: square
fillval: NAN
weight_type: ivm
output_shape: None
crpix: None
crval: None
rotation: None
pixel_scale_ratio: 1.0
pixel_scale: None
output_wcs: ''
single: False
blendheaders: True
in_memory: True
enable_ctx: True
enable_err: True
report_var: True
2025-09-13 16:27:31,477 - stpipe.Image2Pipeline - INFO - Prefetching reference files for dataset: 'jw02079004003_06101_00003_nis_rate.fits' reftypes = ['area', 'camera', 'collimator', 'dflat', 'disperser', 'distortion', 'fflat', 'filteroffset', 'flat', 'fore', 'fpa', 'ifufore', 'ifupost', 'ifuslicer', 'msa', 'ote', 'photom', 'regions', 'sflat', 'specwcs', 'wavelengthrange']
2025-09-13 16:27:31,479 - stpipe.Image2Pipeline - INFO - Prefetch for AREA reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_area_0017.fits'.
2025-09-13 16:27:31,479 - stpipe.Image2Pipeline - INFO - Prefetch for CAMERA reference file is 'N/A'.
2025-09-13 16:27:31,480 - stpipe.Image2Pipeline - INFO - Prefetch for COLLIMATOR reference file is 'N/A'.
2025-09-13 16:27:31,480 - stpipe.Image2Pipeline - INFO - Prefetch for DFLAT reference file is 'N/A'.
2025-09-13 16:27:31,480 - stpipe.Image2Pipeline - INFO - Prefetch for DISPERSER reference file is 'N/A'.
2025-09-13 16:27:31,481 - stpipe.Image2Pipeline - INFO - Prefetch for DISTORTION reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_distortion_0037.asdf'.
2025-09-13 16:27:31,481 - stpipe.Image2Pipeline - INFO - Prefetch for FFLAT reference file is 'N/A'.
2025-09-13 16:27:31,481 - stpipe.Image2Pipeline - INFO - Prefetch for FILTEROFFSET reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_filteroffset_0006.asdf'.
2025-09-13 16:27:31,482 - stpipe.Image2Pipeline - INFO - Prefetch for FLAT reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_flat_0268.fits'.
2025-09-13 16:27:31,482 - stpipe.Image2Pipeline - INFO - Prefetch for FORE reference file is 'N/A'.
2025-09-13 16:27:31,482 - stpipe.Image2Pipeline - INFO - Prefetch for FPA reference file is 'N/A'.
2025-09-13 16:27:31,483 - stpipe.Image2Pipeline - INFO - Prefetch for IFUFORE reference file is 'N/A'.
2025-09-13 16:27:31,483 - stpipe.Image2Pipeline - INFO - Prefetch for IFUPOST reference file is 'N/A'.
2025-09-13 16:27:31,483 - stpipe.Image2Pipeline - INFO - Prefetch for IFUSLICER reference file is 'N/A'.
2025-09-13 16:27:31,483 - stpipe.Image2Pipeline - INFO - Prefetch for MSA reference file is 'N/A'.
2025-09-13 16:27:31,484 - stpipe.Image2Pipeline - INFO - Prefetch for OTE reference file is 'N/A'.
2025-09-13 16:27:31,484 - stpipe.Image2Pipeline - INFO - Prefetch for PHOTOM reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_photom_0046.fits'.
2025-09-13 16:27:31,485 - stpipe.Image2Pipeline - INFO - Prefetch for REGIONS reference file is 'N/A'.
2025-09-13 16:27:31,486 - stpipe.Image2Pipeline - INFO - Prefetch for SFLAT reference file is 'N/A'.
2025-09-13 16:27:31,486 - stpipe.Image2Pipeline - INFO - Prefetch for SPECWCS reference file is 'N/A'.
2025-09-13 16:27:31,486 - stpipe.Image2Pipeline - INFO - Prefetch for WAVELENGTHRANGE reference file is 'N/A'.
2025-09-13 16:27:31,487 - stpipe.Image2Pipeline - INFO - Starting calwebb_image2 ...
2025-09-13 16:27:31,487 - stpipe.Image2Pipeline - INFO - Processing product /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage1/jw02079004003_06101_00003_nis
2025-09-13 16:27:31,487 - stpipe.Image2Pipeline - INFO - Working on input /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage1/jw02079004003_06101_00003_nis_rate.fits ...
2025-09-13 16:27:31,743 - stpipe.Image2Pipeline.assign_wcs - INFO - Step assign_wcs running with args (<ImageModel(2048, 2048) from /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage2_img/jw02079004003_06101_00003_nis_image2pipeline.fits>,).
2025-09-13 16:27:31,826 - jwst.assign_wcs.niriss - INFO - Offsets from filteroffset file are 2.119, -1.0476
2025-09-13 16:27:31,878 - stcal.alignment.util - INFO - Update S_REGION to POLYGON ICRS 53.149298003 -27.809438531 53.189173055 -27.796981956 53.175000702 -27.762027740 53.135161034 -27.774462239
2025-09-13 16:27:31,879 - jwst.assign_wcs.assign_wcs - INFO - assign_wcs updated S_REGION to POLYGON ICRS 53.149298003 -27.809438531 53.189173055 -27.796981956 53.175000702 -27.762027740 53.135161034 -27.774462239
2025-09-13 16:27:31,879 - jwst.assign_wcs.assign_wcs - INFO - COMPLETED assign_wcs
2025-09-13 16:27:31,925 - stpipe.Image2Pipeline.assign_wcs - INFO - Step assign_wcs done
2025-09-13 16:27:32,136 - stpipe.Image2Pipeline.flat_field - INFO - Step flat_field running with args (<ImageModel(2048, 2048) from /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage2_img/jw02079004003_06101_00003_nis_image2pipeline.fits>,).
2025-09-13 16:27:32,205 - stpipe.Image2Pipeline.flat_field - INFO - Using FLAT reference file: /home/runner/crds/references/jwst/niriss/jwst_niriss_flat_0268.fits
2025-09-13 16:27:32,206 - stpipe.Image2Pipeline.flat_field - INFO - No reference found for type FFLAT
2025-09-13 16:27:32,206 - stpipe.Image2Pipeline.flat_field - INFO - No reference found for type SFLAT
2025-09-13 16:27:32,206 - stpipe.Image2Pipeline.flat_field - INFO - No reference found for type DFLAT
2025-09-13 16:27:32,363 - stpipe.Image2Pipeline.flat_field - INFO - Step flat_field done
2025-09-13 16:27:32,579 - stpipe.Image2Pipeline.photom - INFO - Step photom running with args (<ImageModel(2048, 2048) from /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage2_img/jw02079004003_06101_00003_nis_image2pipeline.fits>,).
2025-09-13 16:27:32,590 - stpipe.Image2Pipeline.photom - INFO - Using photom reference file: /home/runner/crds/references/jwst/niriss/jwst_niriss_photom_0046.fits
2025-09-13 16:27:32,591 - stpipe.Image2Pipeline.photom - INFO - Using area reference file: /home/runner/crds/references/jwst/niriss/jwst_niriss_area_0017.fits
2025-09-13 16:27:32,625 - jwst.photom.photom - INFO - Using instrument: NIRISS
2025-09-13 16:27:32,626 - jwst.photom.photom - INFO - detector: NIS
2025-09-13 16:27:32,626 - jwst.photom.photom - INFO - exp_type: NIS_IMAGE
2025-09-13 16:27:32,626 - jwst.photom.photom - INFO - filter: CLEAR
2025-09-13 16:27:32,627 - jwst.photom.photom - INFO - pupil: F200W
2025-09-13 16:27:32,652 - jwst.photom.photom - INFO - Pixel area map copied to output.
2025-09-13 16:27:32,653 - jwst.photom.photom - INFO - Values for PIXAR_SR and PIXAR_A2 obtained from AREA reference file.
2025-09-13 16:27:32,654 - jwst.photom.photom - INFO - PHOTMJSR value: 0.258197
2025-09-13 16:27:32,707 - stpipe.Image2Pipeline.photom - INFO - Step photom done
2025-09-13 16:27:32,920 - stpipe.Image2Pipeline.resample - INFO - Step resample running with args (<ImageModel(2048, 2048) from /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage2_img/jw02079004003_06101_00003_nis_image2pipeline.fits>,).
2025-09-13 16:27:32,920 - stpipe.Image2Pipeline.resample - INFO - Step skipped.
2025-09-13 16:27:32,922 - stpipe.Image2Pipeline - INFO - Finished processing product /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage1/jw02079004003_06101_00003_nis
2025-09-13 16:27:32,923 - stpipe.Image2Pipeline - INFO - ... ending calwebb_image2
2025-09-13 16:27:32,923 - jwst.stpipe.core - INFO - Results used CRDS context: jwst_1413.pmap
2025-09-13 16:27:33,097 - stpipe.Image2Pipeline - INFO - Saved model in /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage2_img/jw02079004003_06101_00003_nis_cal.fits
2025-09-13 16:27:33,098 - stpipe.Image2Pipeline - INFO - Step Image2Pipeline done
2025-09-13 16:27:33,098 - jwst.stpipe.core - INFO - Results used jwst version: 1.19.1
# Print out the time benchmark
time_image2_end = time.perf_counter()
print(f"Runtime for Image2: {(time_image2_end - time_image2):0.0f} seconds")
Runtime for Image2: 133 seconds
7. Image3 Pipeline#
In this section we continue calibrating the direct images with the Image3 stage of the pipeline to obtain a source catalog and segmentation mapping of the field to use as input into the Spec2 stage later. In the Image3 stage of the pipeline, the individual *_cal.fits
files for each of the dither positions are combined to one single distortion corrected image (*_i2d.fits
files).
By default, the Image3 stage of the pipeline performs the following steps on NIRISS data:
tweakreg - creates source catalogs of pointlike sources for each input image. The source catalog for each input image is compared to each other to derive coordinate transforms to align the images relative to each other.
As of CRDS context jwst_1156.pmap and later, the pars-tweakreg parameter reference file for NIRISS performs an absolute astrometric correction to GAIA data release 3 by default (i.e., the abs_refcat parameter is set to GAIADR3). Though this default correction generally improves results compared with not doing this alignment, it could potentially result in poor performance in crowded or sparse fields, so users are encouraged to check astrometric accuracy and revisit this step if necessary.
As of pipeline version 1.14.0, the default source finding algorithm for NIRISS is IRAFStarFinder which testing shows returns good accuracy for undersampled NIRISS PSFs at short wavelengths (Goudfrooij 2022).
skymatch - measures the background level from the sky to use as input into the subsequent outlier detection and resample steps.
outlier detection - flags any remaining cosmic rays, bad pixels, or other artifacts not already flagged during the detector1 stage of the pipeline, using all input images to create a median image so that outliers in individual images can be identified.
resample - resamples each input image based on its WCS and distortion information and creates a single undistorted image.
source catalog - creates a catalog of detected sources along with measured photometries and morphologies (i.e., point-like vs extended). Useful for quicklooks, but optimization is likely needed for specific science cases, which is an on-going investigation for the NIRISS team. Users may wish to experiment with changing the snr_threshold and deblend options. Modifications to the following parameters will not significantly improve data quality and it is advised to keep them at their default values: aperture_ee1, aperture_ee2, aperture_ee3, ci1_star_threshold, ci2_star_threshold.
time_image3 = time.perf_counter()
Find and sort all of the input image2 cal files, ensuring use of absolute paths
# Science Files need the cal.fits files
sstring = os.path.join(image2_dir, 'jw*cal.fits')
img3_cal_files = sorted(glob.glob(sstring))
for ii, cal_relpath in enumerate(img3_cal_files):
img3_cal_files[ii] = os.path.abspath(cal_relpath)
img3_cal_files = np.array(img3_cal_files)
print(f'Found {str(len(img3_cal_files))} imaging cal files to process for level 3')
Found 8 imaging cal files to process for level 3
Create Image3 Association Files#
An association file lists the exposures to calibrated together in the Image3 stage of the pipeline. Note that an association file is available for download from MAST, with a filename of *image3_asn.json
. Additionally, you can download the _pool.csv
file for a specific observation and create associations directly from the pool file using the asn_generate function with the latest version of the pipeline. In both of these cases, the pipeline is expecting the files being calibrated to exist in the same directory that the association is in. Below, we show how to create an image3 association file by providing a list of exposures that we have processed through the pipeline and saved in separate directories. Also note that the output products will have a rootname that is specified by the product_name
in the association file. For this tutorial, the rootname of the output products will end with image3_asn.json
.
# Create Level 3 Associations for each pupil (blocking filter) type
if doimage3:
# Parameters to be used for the NIRISS imaging 3 association creation
img3_pid = str(program) # associations are only set up to combine for the same program & observation
img3_obs = str(sci_observtn) # associations are only set up to combine for the same program & observation
img3_filt = 'CLEAR' # For imaging mode, the second filter wheel is set to clear
img3_ins = 'NIRISS'
# Identify the unique filters used (keyword=PUPIL) for the NIRISS images
img3_all_pupils = np.array([fits.getval(cf, 'PUPIL') for cf in img3_cal_files])
img3_uniq_pupils = np.unique(img3_all_pupils)
# Loop over unique pupil values
for img3_pupil in img3_uniq_pupils:
img3_indx = np.where(img3_all_pupils == img3_pupil)[0]
img3_pupil_files = img3_cal_files[img3_indx]
# setting up the association filename to match the default pipeline level3 naming output
img3_product_name = f"jw{img3_pid}-o{img3_obs}_{img3_ins}_{img3_filt}-{img3_pupil}".lower()
img3_asn_filename = img3_product_name + '_image3_asn.json'
img3_association = asn_from_list.asn_from_list(img3_pupil_files, rule=DMS_Level3_Base,
product_name=img3_product_name)
img3_association.data['asn_type'] = 'image3'
img3_association.data['program'] = img3_pid
# Format association as .json file
_, serialized = img3_association.dump(format="json")
# Write out association file
img3_asn_pathname = os.path.join(sci_dir, img3_asn_filename)
with open(img3_asn_pathname, "w") as fd:
fd.write(serialized)
print(f'Writing image3 association: {img3_asn_pathname}')
Writing image3 association: /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/jw02079-o004_niriss_clear-f200w_image3_asn.json
Take a quick look at the contents of the first image3 association file to get a feel for what is being associated
if doimage3:
image3_asns = glob.glob(os.path.join(sci_dir, "*image3*_asn.json"))
# open the image3 association to look at
image3_asn_data = json.load(open(image3_asns[0]))
print(f'asn_type : {image3_asn_data["asn_type"]}')
print(f'code_version : {image3_asn_data["code_version"]}')
# in particular, take a closer look at the product filenames with the association file:
for product in image3_asn_data['products']:
for key, value in product.items():
if key == 'members':
print(f"{key}:")
for member in value:
print(f" {member['expname']} {member['exptype']}")
else:
print(f"{key}: {value}")
asn_type : image3
code_version : 1.19.1
name: jw02079-o004_niriss_clear-f200w
members:
/home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage2_img/jw02079004003_02101_00001_nis_cal.fits science
/home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage2_img/jw02079004003_04101_00001_nis_cal.fits science
/home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage2_img/jw02079004003_04101_00002_nis_cal.fits science
/home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage2_img/jw02079004003_04101_00003_nis_cal.fits science
/home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage2_img/jw02079004003_04101_00004_nis_cal.fits science
/home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage2_img/jw02079004003_06101_00001_nis_cal.fits science
/home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage2_img/jw02079004003_06101_00002_nis_cal.fits science
/home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage2_img/jw02079004003_06101_00003_nis_cal.fits science
Run Image3#
In Image3, the *_cal.fits
individual pointing files will be calibrated into a single combined *_i2d.fits
image. The parameters in each of the Image3 steps can be modified from the default values, including overwriting reference files that are used during this stage. This dictionary of the modified parameters for each of the steps is then fed into the steps
parameter of the Image3Pipeline
call. The syntax for modifying some of these parameters is below; the full list of parameters can be found in the tweakreg and sourcecatalog documentation.
# Set up a dictionary to define how the Image3 pipeline should be configured
# this sets up any entry to image3dict to be a dictionary itself
image3dict = defaultdict(dict)
# -----------------------------Set step parameters------------------------------
# Example overrides for whether or not certain steps should be skipped
# Some of these example values differ from default values to improve the demo scene
# image3dict['outlier_detection']['skip'] = True
# Example parameters for the source_catalog step
# image3dict['source_catalog']['kernel_fwhm'] = 5.0
# image3dict['source_catalog']['snr_threshold'] = 10.0
# image3dict['source_catalog']['npixels'] = 50
# image3dict['source_catalog']['deblend'] = True
# Example parameters for the tweakreg step
# image3dict['tweakreg']['snr_threshold'] = 20
# image3dict['tweakreg']['abs_refcat'] = 'GAIADR3'
# image3dict['tweakreg']['searchrad'] = 3.0,
# image3dict['tweakreg']['kernel_fwhm'] = 2.302
# image3dict['tweakreg']['fitgeometry'] = 'shift'
# ---------------------------Override reference files---------------------------
# Example overrides for various reference files
# Files should be in the base local directory or provide full path
# image3dict['source_catalog']['override_apcorr'] = 'myfile.fits' # Aperture correction parameters
# image3dict['source_catalog']['override_abvegaoffset'] = 'myfile.asdf' # Data to convert from AB to Vega magnitudes (ASDF file)
# Run Image3
if doimage3:
asn_files = np.sort(glob.glob(os.path.join(sci_dir, '*image3_asn.json')))
for asn in asn_files:
img3 = Image3Pipeline.call(asn, output_dir=image3_dir, steps=image3dict, save_results=True)
else:
print('Skipping Image3 processing')
2025-09-13 16:27:33,219 - CRDS - INFO - Fetching /home/runner/crds/references/jwst/niriss/jwst_niriss_pars-tweakregstep_0075.asdf 1.7 K bytes (1 / 1 files) (0 / 1.7 K bytes)
2025-09-13 16:27:33,459 - stpipe - INFO - PARS-TWEAKREGSTEP parameters found: /home/runner/crds/references/jwst/niriss/jwst_niriss_pars-tweakregstep_0075.asdf
2025-09-13 16:27:33,470 - CRDS - INFO - Fetching /home/runner/crds/references/jwst/niriss/jwst_niriss_pars-outlierdetectionstep_0002.asdf 5.3 K bytes (1 / 1 files) (0 / 5.3 K bytes)
2025-09-13 16:27:33,725 - stpipe - INFO - PARS-OUTLIERDETECTIONSTEP parameters found: /home/runner/crds/references/jwst/niriss/jwst_niriss_pars-outlierdetectionstep_0002.asdf
2025-09-13 16:27:33,738 - stpipe - INFO - PARS-RESAMPLESTEP parameters found: /home/runner/crds/references/jwst/niriss/jwst_niriss_pars-resamplestep_0001.asdf
2025-09-13 16:27:33,747 - CRDS - INFO - Fetching /home/runner/crds/references/jwst/niriss/jwst_niriss_pars-sourcecatalogstep_0002.asdf 1.3 K bytes (1 / 1 files) (0 / 1.3 K bytes)
2025-09-13 16:27:33,989 - stpipe - INFO - PARS-SOURCECATALOGSTEP parameters found: /home/runner/crds/references/jwst/niriss/jwst_niriss_pars-sourcecatalogstep_0002.asdf
2025-09-13 16:27:34,002 - stpipe.Image3Pipeline - INFO - Image3Pipeline instance created.
2025-09-13 16:27:34,003 - stpipe.Image3Pipeline.assign_mtwcs - INFO - AssignMTWcsStep instance created.
2025-09-13 16:27:34,006 - stpipe.Image3Pipeline.tweakreg - INFO - TweakRegStep instance created.
2025-09-13 16:27:34,007 - stpipe.Image3Pipeline.skymatch - INFO - SkyMatchStep instance created.
2025-09-13 16:27:34,008 - stpipe.Image3Pipeline.outlier_detection - INFO - OutlierDetectionStep instance created.
2025-09-13 16:27:34,009 - stpipe.Image3Pipeline.resample - INFO - ResampleStep instance created.
2025-09-13 16:27:34,010 - stpipe.Image3Pipeline.source_catalog - INFO - SourceCatalogStep instance created.
2025-09-13 16:27:34,225 - stpipe.Image3Pipeline - INFO - Step Image3Pipeline running with args (np.str_('/home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/jw02079-o004_niriss_clear-f200w_image3_asn.json'),).
2025-09-13 16:27:34,237 - stpipe.Image3Pipeline - INFO - Step Image3Pipeline parameters are:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage3_img
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: True
skip: False
suffix: None
search_output_file: True
input_dir: ''
in_memory: True
steps:
assign_mtwcs:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: True
output_use_index: True
save_results: False
skip: False
suffix: assign_mtwcs
search_output_file: True
input_dir: ''
tweakreg:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: True
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
save_catalogs: False
use_custom_catalogs: False
catalog_format: ecsv
catfile: ''
starfinder: iraf
snr_threshold: 10
kernel_fwhm: 2.0
bkg_boxsize: 400
minsep_fwhm: 0.0
sigma_radius: 1.5
sharplo: 0.5
sharphi: 3.0
roundlo: 0.0
roundhi: 0.2
brightest: 100
peakmax: None
npixels: 10
connectivity: '8'
nlevels: 32
contrast: 0.001
multithresh_mode: exponential
localbkg_width: 0
apermask_method: correct
kron_params: None
enforce_user_order: False
expand_refcat: False
minobj: 10
fitgeometry: rshift
nclip: 3
sigma: 3.0
searchrad: 1.0
use2dhist: True
separation: 1.5
tolerance: 1.0
xoffset: 0.0
yoffset: 0.0
abs_refcat: GAIADR3
save_abs_catalog: False
abs_minobj: 15
abs_fitgeometry: rshift
abs_nclip: 3
abs_sigma: 3.0
abs_searchrad: 6.0
abs_use2dhist: True
abs_separation: 1.0
abs_tolerance: 0.7
sip_approx: True
sip_max_pix_error: 0.01
sip_degree: None
sip_max_inv_pix_error: 0.01
sip_inv_degree: None
sip_npoints: 12
in_memory: True
skymatch:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
skymethod: match
match_down: True
subtract: False
skylist: None
stepsize: None
skystat: mode
dqbits: ~DO_NOT_USE+NON_SCIENCE
lower: None
upper: None
nclip: 5
lsigma: 4.0
usigma: 4.0
binwidth: 0.1
in_memory: True
outlier_detection:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: False
input_dir: ''
weight_type: ivm
pixfrac: 1.0
kernel: square
fillval: NAN
maskpt: 0.7
snr: 5.0 4.0
scale: 2.1 0.7
backg: 0.0
kernel_size: 7 7
threshold_percent: 99.8
rolling_window_width: 25
ifu_second_check: False
save_intermediate_results: False
resample_data: True
good_bits: ~DO_NOT_USE
in_memory: True
resample:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
pixfrac: 1.0
kernel: square
fillval: NAN
weight_type: ivm
output_shape: None
crpix: None
crval: None
rotation: None
pixel_scale_ratio: 1.0
pixel_scale: None
output_wcs: ''
single: False
blendheaders: True
in_memory: True
enable_ctx: True
enable_err: True
report_var: True
source_catalog:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: cat
search_output_file: True
input_dir: ''
bkg_boxsize: 100
kernel_fwhm: 3.0
snr_threshold: 3.0
npixels: 5
deblend: False
aperture_ee1: 50
aperture_ee2: 70
aperture_ee3: 80
ci1_star_threshold: 1.4
ci2_star_threshold: 1.275
2025-09-13 16:27:34,296 - stpipe.Image3Pipeline - INFO - Prefetching reference files for dataset: 'jw02079-o004_niriss_clear-f200w_image3_asn.json' reftypes = ['abvegaoffset', 'apcorr']
2025-09-13 16:27:34,298 - CRDS - INFO - Fetching /home/runner/crds/references/jwst/niriss/jwst_niriss_abvegaoffset_0003.asdf 2.1 K bytes (1 / 2 files) (0 / 16.5 K bytes)
2025-09-13 16:27:34,539 - CRDS - INFO - Fetching /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0008.fits 14.4 K bytes (2 / 2 files) (2.1 K / 16.5 K bytes)
2025-09-13 16:27:34,899 - stpipe.Image3Pipeline - INFO - Prefetch for ABVEGAOFFSET reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_abvegaoffset_0003.asdf'.
2025-09-13 16:27:34,899 - stpipe.Image3Pipeline - INFO - Prefetch for APCORR reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0008.fits'.
2025-09-13 16:27:34,900 - stpipe.Image3Pipeline - INFO - Starting calwebb_image3 ...
2025-09-13 16:27:35,417 - stpipe.Image3Pipeline.tweakreg - INFO - Step tweakreg running with args (<jwst.datamodels.library.ModelLibrary object at 0x7faef4204910>,).
2025-09-13 16:27:36,794 - stpipe.Image3Pipeline.tweakreg - INFO - Detected 100 sources in jw02079004003_02101_00001_nis_cal.fits.
2025-09-13 16:27:38,296 - stpipe.Image3Pipeline.tweakreg - INFO - Detected 100 sources in jw02079004003_04101_00001_nis_cal.fits.
2025-09-13 16:27:39,802 - stpipe.Image3Pipeline.tweakreg - INFO - Detected 100 sources in jw02079004003_04101_00002_nis_cal.fits.
2025-09-13 16:27:41,326 - stpipe.Image3Pipeline.tweakreg - INFO - Detected 95 sources in jw02079004003_04101_00003_nis_cal.fits.
2025-09-13 16:27:42,845 - stpipe.Image3Pipeline.tweakreg - INFO - Detected 100 sources in jw02079004003_04101_00004_nis_cal.fits.
2025-09-13 16:27:44,367 - stpipe.Image3Pipeline.tweakreg - INFO - Detected 92 sources in jw02079004003_06101_00001_nis_cal.fits.
2025-09-13 16:27:45,887 - stpipe.Image3Pipeline.tweakreg - INFO - Detected 95 sources in jw02079004003_06101_00002_nis_cal.fits.
2025-09-13 16:27:47,404 - stpipe.Image3Pipeline.tweakreg - INFO - Detected 88 sources in jw02079004003_06101_00003_nis_cal.fits.
2025-09-13 16:27:47,427 - stpipe.Image3Pipeline.tweakreg - INFO -
2025-09-13 16:27:47,428 - stpipe.Image3Pipeline.tweakreg - INFO - Number of image groups to be aligned: 8.
2025-09-13 16:27:47,428 - tweakwcs.imalign - INFO -
2025-09-13 16:27:47,428 - tweakwcs.imalign - INFO - ***** tweakwcs.imalign.align_wcs() started on 2025-09-13 16:27:47.428603
2025-09-13 16:27:47,429 - tweakwcs.imalign - INFO - Version 0.8.11
2025-09-13 16:27:47,429 - tweakwcs.imalign - INFO -
2025-09-13 16:27:53,444 - tweakwcs.imalign - INFO - Selected image 'GROUP ID: jw02079004003_04101_2' as reference image
2025-09-13 16:27:53,448 - tweakwcs.imalign - INFO - Aligning image catalog 'GROUP ID: jw02079004003_04101_1' to the reference catalog.
2025-09-13 16:27:53,528 - tweakwcs.matchutils - INFO - Matching sources from 'jw02079004003_04101_00001_nis_cal' catalog with sources from the reference 'jw02079004003_04101_00002_nis_cal' catalog.
2025-09-13 16:27:53,529 - tweakwcs.matchutils - INFO - Computing initial guess for X and Y shifts...
2025-09-13 16:27:53,530 - tweakwcs.matchutils - INFO - Found initial X and Y shifts of 0.04899, 0.04899 (arcsec) with significance of 74 and 74 matches.
2025-09-13 16:27:53,532 - tweakwcs.wcsimage - INFO - Found 71 matches for 'GROUP ID: jw02079004003_04101_1'...
2025-09-13 16:27:53,532 - tweakwcs.linearfit - INFO - Performing 'rshift' fit
2025-09-13 16:27:53,534 - tweakwcs.wcsimage - INFO - Computed 'rshift' fit for GROUP ID: jw02079004003_04101_1:
2025-09-13 16:27:53,534 - tweakwcs.wcsimage - INFO - XSH: 0.0009577 YSH: 0.000992278 ROT: -0.000323181 SCALE: 1
2025-09-13 16:27:53,535 - tweakwcs.wcsimage - INFO -
2025-09-13 16:27:53,535 - tweakwcs.wcsimage - INFO - FIT RMSE: 0.0101688 FIT MAE: 0.0091014
2025-09-13 16:27:53,535 - tweakwcs.wcsimage - INFO - Final solution based on 68 objects.
2025-09-13 16:27:53,580 - tweakwcs.imalign - INFO - Added 29 unmatched sources from 'GROUP ID: jw02079004003_04101_1' to the reference catalog.
2025-09-13 16:27:54,852 - tweakwcs.imalign - INFO - Aligning image catalog 'GROUP ID: jw02079004003_02101_1' to the reference catalog.
2025-09-13 16:27:54,932 - tweakwcs.matchutils - INFO - Matching sources from 'jw02079004003_02101_00001_nis_cal' catalog with sources from the reference 'jw02079004003_04101_00001_nis_cal' catalog.
2025-09-13 16:27:54,933 - tweakwcs.matchutils - INFO - Computing initial guess for X and Y shifts...
2025-09-13 16:27:54,934 - tweakwcs.matchutils - INFO - Found initial X and Y shifts of 0.04608, 0.05118 (arcsec) with significance of 79.09 and 90 matches.
2025-09-13 16:27:54,936 - tweakwcs.wcsimage - INFO - Found 80 matches for 'GROUP ID: jw02079004003_02101_1'...
2025-09-13 16:27:54,936 - tweakwcs.linearfit - INFO - Performing 'rshift' fit
2025-09-13 16:27:54,938 - tweakwcs.wcsimage - INFO - Computed 'rshift' fit for GROUP ID: jw02079004003_02101_1:
2025-09-13 16:27:54,939 - tweakwcs.wcsimage - INFO - XSH: -0.000107663 YSH: 0.00477453 ROT: 0.000571431 SCALE: 1
2025-09-13 16:27:54,939 - tweakwcs.wcsimage - INFO -
2025-09-13 16:27:54,939 - tweakwcs.wcsimage - INFO - FIT RMSE: 0.010256 FIT MAE: 0.00864958
2025-09-13 16:27:54,940 - tweakwcs.wcsimage - INFO - Final solution based on 77 objects.
2025-09-13 16:27:54,983 - tweakwcs.imalign - INFO - Added 20 unmatched sources from 'GROUP ID: jw02079004003_02101_1' to the reference catalog.
2025-09-13 16:27:55,962 - tweakwcs.imalign - INFO - Aligning image catalog 'GROUP ID: jw02079004003_04101_3' to the reference catalog.
2025-09-13 16:27:56,046 - tweakwcs.matchutils - INFO - Matching sources from 'jw02079004003_04101_00003_nis_cal' catalog with sources from the reference 'jw02079004003_02101_00001_nis_cal' catalog.
2025-09-13 16:27:56,046 - tweakwcs.matchutils - INFO - Computing initial guess for X and Y shifts...
2025-09-13 16:27:56,048 - tweakwcs.matchutils - INFO - Found initial X and Y shifts of 0.04899, 0.04899 (arcsec) with significance of 68.77 and 83 matches.
2025-09-13 16:27:56,049 - tweakwcs.wcsimage - INFO - Found 73 matches for 'GROUP ID: jw02079004003_04101_3'...
2025-09-13 16:27:56,049 - tweakwcs.linearfit - INFO - Performing 'rshift' fit
2025-09-13 16:27:56,051 - tweakwcs.wcsimage - INFO - Computed 'rshift' fit for GROUP ID: jw02079004003_04101_3:
2025-09-13 16:27:56,052 - tweakwcs.wcsimage - INFO - XSH: 0.00504109 YSH: -0.00139883 ROT: 0.00409596 SCALE: 1
2025-09-13 16:27:56,052 - tweakwcs.wcsimage - INFO -
2025-09-13 16:27:56,052 - tweakwcs.wcsimage - INFO - FIT RMSE: 0.0525508 FIT MAE: 0.0203236
2025-09-13 16:27:56,053 - tweakwcs.wcsimage - INFO - Final solution based on 71 objects.
2025-09-13 16:27:56,095 - tweakwcs.imalign - INFO - Added 22 unmatched sources from 'GROUP ID: jw02079004003_04101_3' to the reference catalog.
2025-09-13 16:27:56,794 - tweakwcs.imalign - INFO - Aligning image catalog 'GROUP ID: jw02079004003_06101_2' to the reference catalog.
2025-09-13 16:27:56,874 - tweakwcs.matchutils - INFO - Matching sources from 'jw02079004003_06101_00002_nis_cal' catalog with sources from the reference 'jw02079004003_04101_00003_nis_cal' catalog.
2025-09-13 16:27:56,875 - tweakwcs.matchutils - INFO - Computing initial guess for X and Y shifts...
2025-09-13 16:27:56,876 - tweakwcs.matchutils - INFO - Found initial X and Y shifts of 0.04975, 0.05052 (arcsec) with significance of 69.36 and 86 matches.
2025-09-13 16:27:56,877 - tweakwcs.wcsimage - INFO - Found 74 matches for 'GROUP ID: jw02079004003_06101_2'...
2025-09-13 16:27:56,878 - tweakwcs.linearfit - INFO - Performing 'rshift' fit
2025-09-13 16:27:56,880 - tweakwcs.wcsimage - INFO - Computed 'rshift' fit for GROUP ID: jw02079004003_06101_2:
2025-09-13 16:27:56,880 - tweakwcs.wcsimage - INFO - XSH: 0.00531622 YSH: -0.00381572 ROT: 0.00210083 SCALE: 1
2025-09-13 16:27:56,881 - tweakwcs.wcsimage - INFO -
2025-09-13 16:27:56,881 - tweakwcs.wcsimage - INFO - FIT RMSE: 0.0124326 FIT MAE: 0.00976952
2025-09-13 16:27:56,881 - tweakwcs.wcsimage - INFO - Final solution based on 72 objects.
2025-09-13 16:27:56,924 - tweakwcs.imalign - INFO - Added 21 unmatched sources from 'GROUP ID: jw02079004003_06101_2' to the reference catalog.
2025-09-13 16:27:57,702 - tweakwcs.imalign - INFO - Aligning image catalog 'GROUP ID: jw02079004003_06101_1' to the reference catalog.
2025-09-13 16:27:57,787 - tweakwcs.matchutils - INFO - Matching sources from 'jw02079004003_06101_00001_nis_cal' catalog with sources from the reference 'jw02079004003_06101_00002_nis_cal' catalog.
2025-09-13 16:27:57,787 - tweakwcs.matchutils - INFO - Computing initial guess for X and Y shifts...
2025-09-13 16:27:57,789 - tweakwcs.matchutils - INFO - Found initial X and Y shifts of 0.04899, 0.04899 (arcsec) with significance of 72.67 and 89 matches.
2025-09-13 16:27:57,791 - tweakwcs.wcsimage - INFO - Found 80 matches for 'GROUP ID: jw02079004003_06101_1'...
2025-09-13 16:27:57,792 - tweakwcs.linearfit - INFO - Performing 'rshift' fit
2025-09-13 16:27:57,794 - tweakwcs.wcsimage - INFO - Computed 'rshift' fit for GROUP ID: jw02079004003_06101_1:
2025-09-13 16:27:57,795 - tweakwcs.wcsimage - INFO - XSH: -0.00055258 YSH: 0.0013317 ROT: -0.0032246 SCALE: 1
2025-09-13 16:27:57,795 - tweakwcs.wcsimage - INFO -
2025-09-13 16:27:57,796 - tweakwcs.wcsimage - INFO - FIT RMSE: 0.0332513 FIT MAE: 0.0125554
2025-09-13 16:27:57,796 - tweakwcs.wcsimage - INFO - Final solution based on 78 objects.
2025-09-13 16:27:57,840 - tweakwcs.imalign - INFO - Added 12 unmatched sources from 'GROUP ID: jw02079004003_06101_1' to the reference catalog.
2025-09-13 16:27:58,390 - tweakwcs.imalign - INFO - Aligning image catalog 'GROUP ID: jw02079004003_06101_3' to the reference catalog.
2025-09-13 16:27:58,471 - tweakwcs.matchutils - INFO - Matching sources from 'jw02079004003_06101_00003_nis_cal' catalog with sources from the reference 'jw02079004003_06101_00001_nis_cal' catalog.
2025-09-13 16:27:58,472 - tweakwcs.matchutils - INFO - Computing initial guess for X and Y shifts...
2025-09-13 16:27:58,473 - tweakwcs.matchutils - INFO - Found initial X and Y shifts of 0.05034, 0.04764 (arcsec) with significance of 78.38 and 97 matches.
2025-09-13 16:27:58,474 - tweakwcs.wcsimage - INFO - Found 79 matches for 'GROUP ID: jw02079004003_06101_3'...
2025-09-13 16:27:58,475 - tweakwcs.linearfit - INFO - Performing 'rshift' fit
2025-09-13 16:27:58,477 - tweakwcs.wcsimage - INFO - Computed 'rshift' fit for GROUP ID: jw02079004003_06101_3:
2025-09-13 16:27:58,478 - tweakwcs.wcsimage - INFO - XSH: 0.00219695 YSH: 0.00463927 ROT: -0.0105398 SCALE: 1
2025-09-13 16:27:58,478 - tweakwcs.wcsimage - INFO -
2025-09-13 16:27:58,478 - tweakwcs.wcsimage - INFO - FIT RMSE: 0.0601232 FIT MAE: 0.0214934
2025-09-13 16:27:58,479 - tweakwcs.wcsimage - INFO - Final solution based on 75 objects.
2025-09-13 16:27:58,525 - tweakwcs.imalign - INFO - Added 9 unmatched sources from 'GROUP ID: jw02079004003_06101_3' to the reference catalog.
2025-09-13 16:27:58,814 - tweakwcs.imalign - INFO - Aligning image catalog 'GROUP ID: jw02079004003_04101_4' to the reference catalog.
2025-09-13 16:27:58,896 - tweakwcs.matchutils - INFO - Matching sources from 'jw02079004003_04101_00004_nis_cal' catalog with sources from the reference 'jw02079004003_06101_00003_nis_cal' catalog.
2025-09-13 16:27:58,896 - tweakwcs.matchutils - INFO - Computing initial guess for X and Y shifts...
2025-09-13 16:27:58,898 - tweakwcs.matchutils - INFO - Found initial X and Y shifts of 0.05022, 0.04838 (arcsec) with significance of 82.11 and 107 matches.
2025-09-13 16:27:58,899 - tweakwcs.wcsimage - INFO - Found 89 matches for 'GROUP ID: jw02079004003_04101_4'...
2025-09-13 16:27:58,899 - tweakwcs.linearfit - INFO - Performing 'rshift' fit
2025-09-13 16:27:58,902 - tweakwcs.wcsimage - INFO - Computed 'rshift' fit for GROUP ID: jw02079004003_04101_4:
2025-09-13 16:27:58,902 - tweakwcs.wcsimage - INFO - XSH: 0.000669624 YSH: -0.00067308 ROT: -0.000490466 SCALE: 1
2025-09-13 16:27:58,902 - tweakwcs.wcsimage - INFO -
2025-09-13 16:27:58,903 - tweakwcs.wcsimage - INFO - FIT RMSE: 0.0112533 FIT MAE: 0.00920654
2025-09-13 16:27:58,903 - tweakwcs.wcsimage - INFO - Final solution based on 87 objects.
2025-09-13 16:27:58,947 - tweakwcs.imalign - INFO - Added 11 unmatched sources from 'GROUP ID: jw02079004003_04101_4' to the reference catalog.
2025-09-13 16:27:58,948 - tweakwcs.imalign - INFO -
2025-09-13 16:27:58,948 - tweakwcs.imalign - INFO - ***** tweakwcs.imalign.align_wcs() ended on 2025-09-13 16:27:58.948240
2025-09-13 16:27:58,949 - tweakwcs.imalign - INFO - ***** tweakwcs.imalign.align_wcs() TOTAL RUN TIME: 0:00:11.519637
2025-09-13 16:27:58,949 - tweakwcs.imalign - INFO -
2025-09-13 16:27:58,983 - stpipe.Image3Pipeline.tweakreg - INFO - Aligning to absolute reference catalog: GAIADR3
2025-09-13 16:28:00,025 - stpipe.Image3Pipeline.tweakreg - WARNING - Not enough sources (7) in the reference catalog for the single-group alignment step to perform a fit. Skipping alignment to the input reference catalog!
2025-09-13 16:28:00,044 - stpipe.Image3Pipeline.tweakreg - INFO - Step tweakreg done
2025-09-13 16:28:00,278 - stpipe.Image3Pipeline.skymatch - INFO - Step skymatch running with args (<jwst.datamodels.library.ModelLibrary object at 0x7faef4204910>,).
2025-09-13 16:28:00,436 - stcal.skymatch.skymatch - INFO -
2025-09-13 16:28:00,436 - stcal.skymatch.skymatch - INFO - ***** stcal.skymatch.skymatch.skymatch() started on 2025-09-13 16:28:00.435997
2025-09-13 16:28:00,437 - stcal.skymatch.skymatch - INFO -
2025-09-13 16:28:00,437 - stcal.skymatch.skymatch - INFO - Sky computation method: 'match'
2025-09-13 16:28:00,437 - stcal.skymatch.skymatch - INFO - Sky matching direction: DOWN
2025-09-13 16:28:00,438 - stcal.skymatch.skymatch - INFO - Sky subtraction from image data: OFF
2025-09-13 16:28:00,439 - stcal.skymatch.skymatch - INFO -
2025-09-13 16:28:00,440 - stcal.skymatch.skymatch - INFO - ---- Computing differences in sky values in overlapping regions.
2025-09-13 16:28:09,036 - stcal.skymatch.skymatch - INFO - * Image ID=jw02079004003_02101_00001_nis_cal.fits. Sky background: 0.00388669
2025-09-13 16:28:09,037 - stcal.skymatch.skymatch - INFO - * Image ID=jw02079004003_04101_00001_nis_cal.fits. Sky background: 0.00631545
2025-09-13 16:28:09,038 - stcal.skymatch.skymatch - INFO - * Image ID=jw02079004003_04101_00002_nis_cal.fits. Sky background: 0.00178962
2025-09-13 16:28:09,038 - stcal.skymatch.skymatch - INFO - * Image ID=jw02079004003_04101_00003_nis_cal.fits. Sky background: 0.00978138
2025-09-13 16:28:09,038 - stcal.skymatch.skymatch - INFO - * Image ID=jw02079004003_04101_00004_nis_cal.fits. Sky background: 0.00756106
2025-09-13 16:28:09,039 - stcal.skymatch.skymatch - INFO - * Image ID=jw02079004003_06101_00001_nis_cal.fits. Sky background: 0.00783909
2025-09-13 16:28:09,039 - stcal.skymatch.skymatch - INFO - * Image ID=jw02079004003_06101_00002_nis_cal.fits. Sky background: 0
2025-09-13 16:28:09,040 - stcal.skymatch.skymatch - INFO - * Image ID=jw02079004003_06101_00003_nis_cal.fits. Sky background: 0.00650102
2025-09-13 16:28:09,040 - stcal.skymatch.skymatch - INFO -
2025-09-13 16:28:09,040 - stcal.skymatch.skymatch - INFO - ***** stcal.skymatch.skymatch.skymatch() ended on 2025-09-13 16:28:09.040400
2025-09-13 16:28:09,041 - stcal.skymatch.skymatch - INFO - ***** stcal.skymatch.skymatch.skymatch() TOTAL RUN TIME: 0:00:08.604403
2025-09-13 16:28:09,041 - stcal.skymatch.skymatch - INFO -
2025-09-13 16:28:09,062 - stpipe.Image3Pipeline.skymatch - INFO - Step skymatch done
2025-09-13 16:28:09,295 - stpipe.Image3Pipeline.outlier_detection - INFO - Step outlier_detection running with args (<jwst.datamodels.library.ModelLibrary object at 0x7faef4204910>,).
2025-09-13 16:28:09,296 - stpipe.Image3Pipeline.outlier_detection - INFO - Outlier Detection mode: imaging
2025-09-13 16:28:09,296 - stpipe.Image3Pipeline.outlier_detection - INFO - Outlier Detection asn_id: a3001
2025-09-13 16:28:09,318 - jwst.resample.resample_utils - INFO - Pixel scale ratio (pscale_out/pscale_in): 1.0
2025-09-13 16:28:09,319 - jwst.resample.resample_utils - INFO - Computed output pixel scale: 0.06556239926840049 arcsec.
2025-09-13 16:28:09,340 - stcal.resample.resample - INFO - Output pixel scale: 0.06556239926840049 arcsec.
2025-09-13 16:28:09,340 - stcal.resample.resample - INFO - Driz parameter kernel: square
2025-09-13 16:28:09,341 - stcal.resample.resample - INFO - Driz parameter pixfrac: 1.0
2025-09-13 16:28:09,341 - stcal.resample.resample - INFO - Driz parameter fillval: NAN
2025-09-13 16:28:09,341 - stcal.resample.resample - INFO - Driz parameter weight_type: ivm
2025-09-13 16:28:09,344 - jwst.resample.resample - INFO - 1 exposures to drizzle together
2025-09-13 16:28:11,381 - stcal.resample.resample - INFO - Resampling science and variance data
2025-09-13 16:28:12,269 - stcal.alignment.util - INFO - Update S_REGION to POLYGON ICRS 53.145917557 -27.810589759 53.189329085 -27.797035835 53.174237763 -27.759221604 53.130839450 -27.772770815
2025-09-13 16:28:12,584 - jwst.resample.resample - INFO - 1 exposures to drizzle together
2025-09-13 16:28:14,592 - stcal.resample.resample - INFO - Resampling science and variance data
2025-09-13 16:28:15,479 - stcal.alignment.util - INFO - Update S_REGION to POLYGON ICRS 53.145917557 -27.810589759 53.189329085 -27.797035835 53.174237763 -27.759221604 53.130839450 -27.772770815
2025-09-13 16:28:15,804 - jwst.resample.resample - INFO - 1 exposures to drizzle together
2025-09-13 16:28:17,812 - stcal.resample.resample - INFO - Resampling science and variance data
2025-09-13 16:28:18,698 - stcal.alignment.util - INFO - Update S_REGION to POLYGON ICRS 53.145917557 -27.810589759 53.189329085 -27.797035835 53.174237763 -27.759221604 53.130839450 -27.772770815
2025-09-13 16:28:19,055 - jwst.resample.resample - INFO - 1 exposures to drizzle together
2025-09-13 16:28:21,022 - stcal.resample.resample - INFO - Resampling science and variance data
2025-09-13 16:28:21,907 - stcal.alignment.util - INFO - Update S_REGION to POLYGON ICRS 53.145917557 -27.810589759 53.189329085 -27.797035835 53.174237763 -27.759221604 53.130839450 -27.772770815
2025-09-13 16:28:22,207 - jwst.resample.resample - INFO - 1 exposures to drizzle together
2025-09-13 16:28:24,185 - stcal.resample.resample - INFO - Resampling science and variance data
2025-09-13 16:28:25,071 - stcal.alignment.util - INFO - Update S_REGION to POLYGON ICRS 53.145917557 -27.810589759 53.189329085 -27.797035835 53.174237763 -27.759221604 53.130839450 -27.772770815
2025-09-13 16:28:25,415 - jwst.resample.resample - INFO - 1 exposures to drizzle together
2025-09-13 16:28:27,386 - stcal.resample.resample - INFO - Resampling science and variance data
2025-09-13 16:28:28,274 - stcal.alignment.util - INFO - Update S_REGION to POLYGON ICRS 53.145917557 -27.810589759 53.189329085 -27.797035835 53.174237763 -27.759221604 53.130839450 -27.772770815
2025-09-13 16:28:28,626 - jwst.resample.resample - INFO - 1 exposures to drizzle together
2025-09-13 16:28:30,602 - stcal.resample.resample - INFO - Resampling science and variance data
2025-09-13 16:28:31,488 - stcal.alignment.util - INFO - Update S_REGION to POLYGON ICRS 53.145917557 -27.810589759 53.189329085 -27.797035835 53.174237763 -27.759221604 53.130839450 -27.772770815
2025-09-13 16:28:31,828 - jwst.resample.resample - INFO - 1 exposures to drizzle together
2025-09-13 16:28:33,806 - stcal.resample.resample - INFO - Resampling science and variance data
2025-09-13 16:28:34,694 - stcal.alignment.util - INFO - Update S_REGION to POLYGON ICRS 53.145917557 -27.810589759 53.189329085 -27.797035835 53.174237763 -27.759221604 53.130839450 -27.772770815
2025-09-13 16:28:38,651 - stcal.outlier_detection.utils - INFO - Blotting (2048, 2048) <-- (2236, 2202)
2025-09-13 16:28:38,890 - jwst.outlier_detection.utils - INFO - 1577 pixels marked as outliers
2025-09-13 16:28:41,025 - stcal.outlier_detection.utils - INFO - Blotting (2048, 2048) <-- (2236, 2202)
2025-09-13 16:28:41,262 - jwst.outlier_detection.utils - INFO - 1787 pixels marked as outliers
2025-09-13 16:28:43,397 - stcal.outlier_detection.utils - INFO - Blotting (2048, 2048) <-- (2236, 2202)
2025-09-13 16:28:43,636 - jwst.outlier_detection.utils - INFO - 1750 pixels marked as outliers
2025-09-13 16:28:45,748 - stcal.outlier_detection.utils - INFO - Blotting (2048, 2048) <-- (2236, 2202)
2025-09-13 16:28:45,987 - jwst.outlier_detection.utils - INFO - 1673 pixels marked as outliers
2025-09-13 16:28:48,111 - stcal.outlier_detection.utils - INFO - Blotting (2048, 2048) <-- (2236, 2202)
2025-09-13 16:28:48,354 - jwst.outlier_detection.utils - INFO - 1555 pixels marked as outliers
2025-09-13 16:28:50,585 - stcal.outlier_detection.utils - INFO - Blotting (2048, 2048) <-- (2236, 2202)
2025-09-13 16:28:50,826 - jwst.outlier_detection.utils - INFO - 1858 pixels marked as outliers
2025-09-13 16:28:52,972 - stcal.outlier_detection.utils - INFO - Blotting (2048, 2048) <-- (2236, 2202)
2025-09-13 16:28:53,214 - jwst.outlier_detection.utils - INFO - 1875 pixels marked as outliers
2025-09-13 16:28:55,366 - stcal.outlier_detection.utils - INFO - Blotting (2048, 2048) <-- (2236, 2202)
2025-09-13 16:28:55,607 - jwst.outlier_detection.utils - INFO - 1715 pixels marked as outliers
2025-09-13 16:28:55,830 - stpipe.Image3Pipeline.outlier_detection - INFO - Saved model in /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage3_img/jw02079004003_02101_00001_nis_a3001_crf.fits
2025-09-13 16:28:56,002 - stpipe.Image3Pipeline.outlier_detection - INFO - Saved model in /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage3_img/jw02079004003_04101_00001_nis_a3001_crf.fits
2025-09-13 16:28:56,176 - stpipe.Image3Pipeline.outlier_detection - INFO - Saved model in /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage3_img/jw02079004003_04101_00002_nis_a3001_crf.fits
2025-09-13 16:28:56,350 - stpipe.Image3Pipeline.outlier_detection - INFO - Saved model in /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage3_img/jw02079004003_04101_00003_nis_a3001_crf.fits
2025-09-13 16:28:56,526 - stpipe.Image3Pipeline.outlier_detection - INFO - Saved model in /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage3_img/jw02079004003_04101_00004_nis_a3001_crf.fits
2025-09-13 16:28:56,699 - stpipe.Image3Pipeline.outlier_detection - INFO - Saved model in /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage3_img/jw02079004003_06101_00001_nis_a3001_crf.fits
2025-09-13 16:28:56,872 - stpipe.Image3Pipeline.outlier_detection - INFO - Saved model in /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage3_img/jw02079004003_06101_00002_nis_a3001_crf.fits
2025-09-13 16:28:57,043 - stpipe.Image3Pipeline.outlier_detection - INFO - Saved model in /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage3_img/jw02079004003_06101_00003_nis_a3001_crf.fits
2025-09-13 16:28:57,044 - stpipe.Image3Pipeline.outlier_detection - INFO - Step outlier_detection done
2025-09-13 16:28:57,270 - stpipe.Image3Pipeline.resample - INFO - Step resample running with args (<jwst.datamodels.library.ModelLibrary object at 0x7faef4204910>,).
2025-09-13 16:28:57,548 - jwst.resample.resample_utils - INFO - Pixel scale ratio (pscale_out/pscale_in): 1.0
2025-09-13 16:28:57,549 - jwst.resample.resample_utils - INFO - Computed output pixel scale: 0.06556239926840049 arcsec.
2025-09-13 16:28:57,571 - stcal.resample.resample - INFO - Output pixel scale: 0.06556239926840049 arcsec.
2025-09-13 16:28:57,572 - stcal.resample.resample - INFO - Driz parameter kernel: square
2025-09-13 16:28:57,572 - stcal.resample.resample - INFO - Driz parameter pixfrac: 1.0
2025-09-13 16:28:57,573 - stcal.resample.resample - INFO - Driz parameter fillval: NAN
2025-09-13 16:28:57,573 - stcal.resample.resample - INFO - Driz parameter weight_type: ivm
2025-09-13 16:28:57,592 - jwst.resample.resample - INFO - Resampling science and variance data
2025-09-13 16:28:59,592 - stcal.resample.resample - INFO - Resampling science and variance data
2025-09-13 16:29:00,429 - stcal.resample.resample - INFO - Drizzling (2048, 2048) --> (2236, 2202)
2025-09-13 16:29:01,225 - stcal.resample.resample - INFO - Drizzling (2048, 2048) --> (2236, 2202)
2025-09-13 16:29:02,018 - stcal.resample.resample - INFO - Drizzling (2048, 2048) --> (2236, 2202)
2025-09-13 16:29:05,116 - stcal.resample.resample - INFO - Resampling science and variance data
2025-09-13 16:29:05,950 - stcal.resample.resample - INFO - Drizzling (2048, 2048) --> (2236, 2202)
2025-09-13 16:29:06,741 - stcal.resample.resample - INFO - Drizzling (2048, 2048) --> (2236, 2202)
2025-09-13 16:29:07,532 - stcal.resample.resample - INFO - Drizzling (2048, 2048) --> (2236, 2202)
2025-09-13 16:29:10,540 - stcal.resample.resample - INFO - Resampling science and variance data
2025-09-13 16:29:11,374 - stcal.resample.resample - INFO - Drizzling (2048, 2048) --> (2236, 2202)
2025-09-13 16:29:12,164 - stcal.resample.resample - INFO - Drizzling (2048, 2048) --> (2236, 2202)
2025-09-13 16:29:12,954 - stcal.resample.resample - INFO - Drizzling (2048, 2048) --> (2236, 2202)
2025-09-13 16:29:15,939 - stcal.resample.resample - INFO - Resampling science and variance data
2025-09-13 16:29:16,775 - stcal.resample.resample - INFO - Drizzling (2048, 2048) --> (2236, 2202)
2025-09-13 16:29:17,570 - stcal.resample.resample - INFO - Drizzling (2048, 2048) --> (2236, 2202)
2025-09-13 16:29:18,362 - stcal.resample.resample - INFO - Drizzling (2048, 2048) --> (2236, 2202)
2025-09-13 16:29:21,377 - stcal.resample.resample - INFO - Resampling science and variance data
2025-09-13 16:29:22,215 - stcal.resample.resample - INFO - Drizzling (2048, 2048) --> (2236, 2202)
2025-09-13 16:29:23,007 - stcal.resample.resample - INFO - Drizzling (2048, 2048) --> (2236, 2202)
2025-09-13 16:29:23,800 - stcal.resample.resample - INFO - Drizzling (2048, 2048) --> (2236, 2202)
2025-09-13 16:29:26,817 - stcal.resample.resample - INFO - Resampling science and variance data
2025-09-13 16:29:27,652 - stcal.resample.resample - INFO - Drizzling (2048, 2048) --> (2236, 2202)
2025-09-13 16:29:28,443 - stcal.resample.resample - INFO - Drizzling (2048, 2048) --> (2236, 2202)
2025-09-13 16:29:29,233 - stcal.resample.resample - INFO - Drizzling (2048, 2048) --> (2236, 2202)
2025-09-13 16:29:32,261 - stcal.resample.resample - INFO - Resampling science and variance data
2025-09-13 16:29:33,099 - stcal.resample.resample - INFO - Drizzling (2048, 2048) --> (2236, 2202)
2025-09-13 16:29:33,890 - stcal.resample.resample - INFO - Drizzling (2048, 2048) --> (2236, 2202)
2025-09-13 16:29:34,680 - stcal.resample.resample - INFO - Drizzling (2048, 2048) --> (2236, 2202)
2025-09-13 16:29:37,700 - stcal.resample.resample - INFO - Resampling science and variance data
2025-09-13 16:29:38,536 - stcal.resample.resample - INFO - Drizzling (2048, 2048) --> (2236, 2202)
2025-09-13 16:29:39,326 - stcal.resample.resample - INFO - Drizzling (2048, 2048) --> (2236, 2202)
2025-09-13 16:29:40,121 - stcal.resample.resample - INFO - Drizzling (2048, 2048) --> (2236, 2202)
2025-09-13 16:29:41,414 - stcal.alignment.util - INFO - Update S_REGION to POLYGON ICRS 53.145917557 -27.810589759 53.189329085 -27.797035835 53.174237763 -27.759221604 53.130839450 -27.772770815
2025-09-13 16:29:41,703 - stpipe.Image3Pipeline.resample - INFO - Saved model in /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage3_img/jw02079-o004_niriss_clear-f200w_i2d.fits
2025-09-13 16:29:41,704 - stpipe.Image3Pipeline.resample - INFO - Step resample done
2025-09-13 16:29:41,925 - stpipe.Image3Pipeline.source_catalog - INFO - Step source_catalog running with args (<ImageModel(2236, 2202) from jw02079-o004_niriss_clear-f200w_i2d.fits>,).
2025-09-13 16:29:41,958 - stpipe.Image3Pipeline.source_catalog - INFO - Using APCORR reference file: /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0008.fits
2025-09-13 16:29:41,960 - stpipe.Image3Pipeline.source_catalog - INFO - Using ABVEGAOFFSET reference file: /home/runner/crds/references/jwst/niriss/jwst_niriss_abvegaoffset_0003.asdf
2025-09-13 16:29:41,961 - jwst.source_catalog.reference_data - INFO - Instrument: NIRISS
2025-09-13 16:29:41,961 - jwst.source_catalog.reference_data - INFO - Detector: NIS
2025-09-13 16:29:41,962 - jwst.source_catalog.reference_data - INFO - Filter: CLEAR
2025-09-13 16:29:41,962 - jwst.source_catalog.reference_data - INFO - Pupil: F200W
2025-09-13 16:29:41,962 - jwst.source_catalog.reference_data - INFO - Subarray: FULL
2025-09-13 16:29:42,001 - jwst.source_catalog.reference_data - INFO - AB to Vega magnitude offset 1.68884
2025-09-13 16:29:45,368 - jwst.source_catalog.detection - INFO - Detected 1502 sources
2025-09-13 16:29:46,185 - stpipe.Image3Pipeline.source_catalog - INFO - Wrote source catalog: /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage3_img/jw02079-o004_niriss_clear-f200w_cat.ecsv
2025-09-13 16:29:46,294 - stpipe.Image3Pipeline.source_catalog - INFO - Saved model in /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage3_img/jw02079-o004_niriss_clear-f200w_segm.fits
2025-09-13 16:29:46,295 - stpipe.Image3Pipeline.source_catalog - INFO - Wrote segmentation map: jw02079-o004_niriss_clear-f200w_segm.fits
2025-09-13 16:29:46,297 - stpipe.Image3Pipeline.source_catalog - INFO - Step source_catalog done
2025-09-13 16:29:46,315 - stpipe.Image3Pipeline - INFO - Step Image3Pipeline done
2025-09-13 16:29:46,315 - jwst.stpipe.core - INFO - Results used jwst version: 1.19.1
# Print out the time benchmark
time_image3_end = time.perf_counter()
print(f"Runtime for Image3: {(time_image3_end - time_image3)/60:0.0f} minutes")
Runtime for Image3: 2 minutes
8. Visualize Image3 Output Products#
Using the combined image (*_i2d.fits
), the segmentation map files (*_segm.fits
), and the source catalog (*cat.ecsv
) produced by the Image3 stage of the pipeline, we can visually inspect if we agree with where the sources were found to use further in the Spec2 stage of the pipeline.
# Find the outputs of the Image3 pipeline, which will be needed for processing the spectral data
# Print which outputs were found for reference
# Combined image over multiple dithers/mosaic
image3_i2d = np.sort(glob.glob(os.path.join(image3_dir, '*i2d.fits')))
print('Direct images:')
for i2d_filename in image3_i2d:
print(f" {os.path.basename(i2d_filename)}")
# Segmentation map that defines the extent of a source
image3_segm = np.sort(glob.glob(os.path.join(image3_dir, '*segm.fits')))
print('Segmentation maps:')
for seg_filename in image3_segm:
print(f" {os.path.basename(seg_filename)}")
# Source catalog that defines the RA/Dec of a source at a particular pixel
image3_cat = np.sort(glob.glob(os.path.join(image3_dir, '*cat.ecsv')))
print('Source catalogs:')
for cat_filename in image3_cat:
print(f" {os.path.basename(cat_filename)}")
Direct images:
jw02079-o004_niriss_clear-f200w_i2d.fits
Segmentation maps:
jw02079-o004_niriss_clear-f200w_segm.fits
Source catalogs:
jw02079-o004_niriss_clear-f200w_cat.ecsv
i2d & segementation mapping#
The segmentation maps are used the help determine the source catalog. Let’s take a look at those to ensure we agree with what is being defined as a source. In the following figures, the combined image is shown on the left and the the segmentation map is shown on the right, where each black blob in the segmentation map should correspond to a physical target. The sources identified in the source catalog are overlayed on top of both of these, where what has been defined as an extended source by the pipeline is shown as a blue circle, and what has been defined as a point source by the pipeline is shown as a pink square. This definition affects the extraction box in the WFSS images as well as in the contamination correction step of the pipeline, so it is important to get correct.
There are cases where sources can be blended, in which case the parameters for making the segmentation map and source catalog should be modified. If using the demo data, an example of this can be seen in the Observation 004 F200W filter image where two galaxies at ~(1600, 1300) have been blended into one source. This is discussed in more detail in the custom Image3 run in the NIRISS WFSS JDAT notebooks.
if doviz:
cols = 2
rows = len(image3_i2d)
fig = plt.figure(figsize=(15, 15*(rows/2)))
for plt_num, img in enumerate(np.sort(np.concatenate([image3_segm, image3_i2d]))):
# determine where the subplot should be
xpos = (plt_num % 40) % cols
ypos = ((plt_num % 40) // cols) # // to make it an int.
# make the subplot
ax = plt.subplot2grid((rows, cols), (ypos, xpos))
if 'i2d' in img:
cat = Table.read(img.replace('i2d.fits', 'cat.ecsv'))
cmap = 'gist_gray_r'
else:
cmap = 'gist_gray_r'
# plot the image
with fits.open(img) as hdu:
display_vals = [np.nanpercentile(hdu[1].data, 1), np.nanpercentile(hdu[1].data, 99)]
ax.imshow(hdu[1].data, vmin=display_vals[0], vmax=display_vals[1], origin='lower', cmap=cmap)
title = f"{hdu[0].header['PUPIL']}"
# also plot the associated catalog
extended_sources = cat[cat['is_extended'] == 1] # 1 is True; i.e. is extended
point_sources = cat[cat['is_extended'] == 0] # 0 is False; i.e. is a point source
for color, sources, source_type, marker in zip(['deepskyblue', 'deeppink'], [extended_sources, point_sources], ['Extended Source', 'Point Source'], ['o', 's']):
# plotting the sources
ax.scatter(sources['xcentroid'], sources['ycentroid'], marker=marker, s=150, facecolors='None', edgecolors=color, alpha=0.9)
# adding source labels
for i, source_num in enumerate(sources['label']):
ax.annotate(source_num,
(sources['xcentroid'][i]+1, sources['ycentroid'][i]+1),
fontsize=10,
color=color)
ax.scatter(-999, -999, marker=marker, label=source_type, s=150, facecolors='None', edgecolors=color, alpha=0.9)
# setting titles
if 'i2d' in img:
ax.set_title(f"{title} combined image\n(i2d)", fontsize=16)
else:
ax.set_title(f"{title} segmentation map\n(segm)", fontsize=16)
# zooming in on a smaller region
ax.set_xlim(1250, 1750)
ax.set_ylim(1250, 1750)
ax.legend(framealpha=0.6, fontsize=14, loc='upper left')
# more labels
fig.supxlabel('x-pixel', fontsize=14)
fig.supylabel('y-pixel', fontsize=14, x=0)
# Helps to make the axes not overlap ; you can also set this manually if this doesn't work
plt.tight_layout()

In addition to the segmentation mapping, the source catalog itself can be useful to look at to examine the source centroids, calculated fluxes, and source extents
# Print a source catalogs to illustrate the contents
cat = Table.read(image3_cat[0])
cat
label | xcentroid | ycentroid | sky_centroid | aper_bkg_flux | aper_bkg_flux_err | aper50_flux | aper50_flux_err | aper70_flux | aper70_flux_err | aper80_flux | aper80_flux_err | aper_total_flux | aper_total_flux_err | aper50_abmag | aper50_abmag_err | aper70_abmag | aper70_abmag_err | aper80_abmag | aper80_abmag_err | aper_total_abmag | aper_total_abmag_err | aper50_vegamag | aper50_vegamag_err | aper70_vegamag | aper70_vegamag_err | aper80_vegamag | aper80_vegamag_err | aper_total_vegamag | aper_total_vegamag_err | CI_70_50 | CI_80_70 | CI_80_50 | is_extended | sharpness | roundness | nn_label | nn_dist | isophotal_flux | isophotal_flux_err | isophotal_abmag | isophotal_abmag_err | isophotal_vegamag | isophotal_vegamag_err | isophotal_area | semimajor_sigma | semiminor_sigma | ellipticity | orientation | sky_orientation | sky_bbox_ll | sky_bbox_ul | sky_bbox_lr | sky_bbox_ur |
---|---|---|---|---|---|---|---|---|---|---|---|---|---|---|---|---|---|---|---|---|---|---|---|---|---|---|---|---|---|---|---|---|---|---|---|---|---|---|---|---|---|---|---|---|---|---|---|---|---|---|---|---|---|
deg,deg | Jy | Jy | Jy | Jy | Jy | Jy | Jy | Jy | Jy | Jy | pix | Jy | Jy | pix2 | pix | pix | deg | deg | deg,deg | deg,deg | deg,deg | deg,deg | |||||||||||||||||||||||||||||||
int32 | float64 | float64 | SkyCoord | float64 | float64 | float64 | float64 | float64 | float64 | float64 | float64 | float64 | float64 | float64 | float64 | float64 | float64 | float64 | float64 | float64 | float64 | float64 | float64 | float64 | float64 | float64 | float64 | float64 | float64 | float64 | float64 | float64 | bool | float64 | float32 | int32 | float64 | float64 | float32 | float64 | float64 | float64 | float64 | float64 | float64 | float64 | float64 | float64 | float64 | SkyCoord | SkyCoord | SkyCoord | SkyCoord |
1 | 2092.0423 | 10.7385 | 53.131806867324514,-27.774582701377266 | 2.086608e-09 | 2.753818e-10 | 3.717468e-09 | 3.692018e-09 | 7.918225e-09 | 5.782515e-09 | 1.878491e-08 | 9.065374e-09 | 2.505702e-08 | 1.209222e-08 | 29.974382 | 0.748852 | 29.153430 | 0.595290 | 28.215477 | 0.427551 | 27.902676 | 0.427551 | 28.285540 | 0.748852 | 27.464588 | 0.595290 | 26.526635 | 0.427551 | 26.213834 | 0.427551 | 2.1300 | 2.3724 | 5.0531 | True | 4.406951 | 0.280401 | 2 | 21.463468 | 1.989703e-07 | 1.402455e-08 | 25.653029 | 0.073952 | 23.964187 | 0.073952 | 78.0 | 3.864528 | 1.804311 | 0.533110 | -37.543913 | 123.018095 | 53.13173739715103,-27.774750025738495 | 53.13198974807871,-27.774671288800636 | 53.13163471722355,-27.774492398568754 | 53.13188706762742,-27.774413661817103 |
2 | 2113.0013 | 6.1124 | 53.131573596728124,-27.774250746147274 | 1.179825e-09 | 2.850809e-10 | 6.235441e-08 | 3.949722e-09 | nan | nan | nan | nan | nan | nan | 26.912832 | 0.066684 | nan | nan | nan | nan | nan | nan | 25.223990 | 0.066684 | nan | nan | nan | nan | nan | nan | nan | nan | nan | False | nan | nan | 1 | 21.463468 | 1.435018e-07 | 7.618219e-09 | 26.007857 | 0.056162 | 24.319015 | 0.056162 | 26.0 | 1.553609 | 1.011464 | 0.348958 | 1.813147 | 162.375156 | 53.13156626420893,-27.77432064708055 | 53.1316633219654,-27.774290363816537 | 53.131511501952936,-27.77418324586596 | 53.13160855960196,-27.774152962640134 |
3 | 2172.1573 | 13.3414 | 53.131308985723976,-27.7731909493308 | 8.440077e-09 | 1.846055e-09 | 1.093816e-08 | 3.990790e-09 | 2.596599e-08 | 5.891736e-09 | 6.711707e-08 | 8.718647e-09 | 8.952685e-08 | 1.162972e-08 | 28.802640 | 0.337713 | 27.863988 | 0.222025 | 26.832918 | 0.132602 | 26.520117 | 0.132602 | 27.113798 | 0.337713 | 26.175146 | 0.222025 | 25.144076 | 0.132602 | 24.831275 | 0.132602 | 2.3739 | 2.5848 | 6.1360 | True | 0.390794 | nan | 4 | 8.351010 | 1.669037e-06 | 2.832697e-08 | 23.343835 | 0.018273 | 21.654993 | 0.018273 | 358.0 | 6.705066 | 3.395914 | 0.493530 | 0.286540 | 160.848548 | 53.13124453793721,-27.773513414639062 | 53.13167158888475,-27.773380168757445 | 53.13101180276134,-27.772929458796597 | 53.1314388516996,-27.772796213629235 |
4 | 2175.7717 | 5.8131 | 53.13113810968405,-27.773174467434345 | 3.625663e-08 | 1.574255e-15 | nan | nan | nan | nan | nan | nan | nan | nan | nan | nan | nan | nan | nan | nan | nan | nan | nan | nan | nan | nan | nan | nan | nan | nan | nan | nan | nan | False | nan | nan | 3 | 8.351010 | 3.986679e-06 | 1.931909e-08 | 22.398472 | 0.005249 | 20.709630 | 0.005249 | 21.0 | 1.681931 | 0.648419 | 0.614479 | 19.259313 | 179.821321 | 53.13112817003676,-27.77322143676601 | 53.13124463830653,-27.773185097207726 | 53.131059718622595,-27.773049685030973 | 53.13117618673118,-27.77301334552997 |
5 | 1727.7419 | 6.3977 | 53.13421650591276,-27.780865881825783 | -2.876129e-10 | 3.729205e-10 | nan | nan | nan | nan | nan | nan | nan | nan | nan | nan | nan | nan | nan | nan | nan | nan | nan | nan | nan | nan | nan | nan | nan | nan | nan | nan | nan | False | nan | nan | 30 | 5.249273 | 2.015398e-08 | 3.744637e-09 | 28.139098 | 0.185030 | 26.450256 | 0.185030 | 7.0 | 0.991026 | 0.475100 | 0.520598 | 7.765421 | 168.327430 | 53.134214427872244,-27.780909823216003 | 53.13427266562073,-27.780891652157518 | 53.134180197279726,-27.78082394810623 | 53.13423843498791,-27.780805777062074 |
6 | 1768.4993 | 6.6351 | 53.13394208654959,-27.780164432825675 | 1.423811e-09 | 3.204274e-10 | nan | nan | nan | nan | nan | nan | nan | nan | nan | nan | nan | nan | nan | nan | nan | nan | nan | nan | nan | nan | nan | nan | nan | nan | nan | nan | nan | False | nan | nan | 30 | 37.934864 | 6.149357e-08 | 7.311170e-09 | 26.927926 | 0.121972 | 25.239084 | 0.121972 | 25.0 | 2.729647 | 0.709533 | 0.740064 | 1.857092 | 162.419101 | 53.133967968813074,-27.780291522238688 | 53.13404561875326,-27.780267294292795 | 53.133878970397326,-27.780068246779052 | 53.13395662019781,-27.78004401888282 |
7 | 1888.8026 | 7.0269 | 53.13312610621078,-27.77809584439493 | 1.441816e-09 | 4.521603e-10 | 7.820959e-09 | 3.472108e-09 | nan | nan | nan | nan | nan | nan | 29.166850 | 0.398880 | nan | nan | nan | nan | nan | nan | 27.478008 | 0.398880 | nan | nan | nan | nan | nan | nan | nan | nan | nan | False | nan | nan | 56 | 11.521304 | 8.744779e-08 | 8.370040e-09 | 26.545628 | 0.099244 | 24.856786 | 0.099244 | 33.0 | 2.709380 | 0.930837 | 0.656439 | 3.973942 | 164.535951 | 53.13313961307681,-27.77821334077266 | 53.133236673871394,-27.778183056411248 | 53.13305746382077,-27.778007239864312 | 53.1331545244542,-27.777976955560202 |
8 | 1997.4229 | 66.7178 | 53.133541237460456,-27.775868743468276 | 1.536490e-06 | 1.053844e-07 | nan | nan | nan | nan | nan | nan | nan | nan | nan | nan | nan | nan | nan | nan | nan | nan | nan | nan | nan | nan | nan | nan | nan | nan | nan | nan | nan | False | nan | nan | 113 | 42.586035 | 2.121192e-04 | 1.470205e-07 | 18.083550 | 0.000752 | 16.394708 | 0.000752 | 6377.0 | 12.764873 | 10.022105 | 0.214868 | -1.323718 | 159.238291 | 53.13294793196391,-27.777732438578255 | 53.13580148574878,-27.77684205396629 | 53.131763654122274,-27.774761144208266 | 53.134617139596585,-27.773870783883993 |
9 | 2007.9310 | 8.4559 | 53.132338336303384,-27.776041148018525 | 9.870497e-10 | 3.616401e-10 | nan | nan | nan | nan | nan | nan | nan | nan | nan | nan | nan | nan | nan | nan | nan | nan | nan | nan | nan | nan | nan | nan | nan | nan | nan | nan | nan | False | nan | nan | 10 | 8.455170 | 4.589461e-08 | 5.874532e-09 | 27.245596 | 0.130773 | 25.556754 | 0.130773 | 16.0 | 1.149300 | 1.043884 | 0.091722 | 27.546744 | 188.108753 | 53.132297597968,-27.77610080417943 | 53.1324140689326,-27.776064463642342 | 53.132256524897315,-27.775997753484557 | 53.132372995765174,-27.775961412981836 |
... | ... | ... | ... | ... | ... | ... | ... | ... | ... | ... | ... | ... | ... | ... | ... | ... | ... | ... | ... | ... | ... | ... | ... | ... | ... | ... | ... | ... | ... | ... | ... | ... | ... | ... | ... | ... | ... | ... | ... | ... | ... | ... | ... | ... | ... | ... | ... | ... | ... | ... | ... | ... | ... |
1494 | 1019.8891 | 2219.7140 | 53.18202818163738,-27.779608950512205 | 6.992588e-09 | 1.358182e-09 | 1.750539e-07 | 3.539720e-09 | 3.098310e-07 | 4.938517e-09 | 4.493462e-07 | 6.668861e-09 | 5.993788e-07 | 8.895534e-09 | 25.792071 | 0.021735 | 25.172188 | 0.017170 | 24.768547 | 0.015995 | 24.455746 | 0.015995 | 24.103229 | 0.021735 | 23.483346 | 0.017170 | 23.079705 | 0.015995 | 22.766904 | 0.015995 | 1.7699 | 1.4503 | 2.5669 | True | 0.248040 | -0.134577 | 1453 | 71.785268 | 1.127974e-06 | 1.361352e-08 | 23.769252 | 0.013025 | 22.080410 | 0.013025 | 147.0 | 3.055793 | 2.110209 | 0.309440 | -57.058836 | 103.503173 | 53.181931948676926,-27.77976241123907 | 53.18222309427587,-27.779671455706072 | 53.18182229154811,-27.77948764849132 | 53.18211343650348,-27.779396693188545 |
1495 | 1215.7894 | 2222.1802 | 53.180733468599364,-27.776229858844506 | 4.485913e-09 | 3.909301e-10 | 1.208971e-09 | 3.181685e-09 | 2.105744e-09 | 4.664289e-09 | 1.052381e-08 | 6.775319e-09 | 1.403761e-08 | 9.037537e-09 | 31.193960 | 1.400284 | 30.591486 | 1.267963 | 28.844568 | 0.539628 | 28.531767 | 0.539628 | 29.505118 | 1.400284 | 28.902644 | 1.267963 | 27.155726 | 0.539628 | 26.842925 | 0.539628 | 1.7418 | 4.9977 | 8.7048 | True | -2.246507 | nan | 1502 | 46.263018 | 5.087064e-07 | 1.477586e-08 | 24.633832 | 0.031087 | 22.944990 | 0.031087 | 145.0 | 4.555549 | 2.308914 | 0.493165 | -8.274684 | 152.287325 | 53.18066862446609,-27.776487471016207 | 53.18090153481836,-27.776414708760583 | 53.18051785498437,-27.776109670845287 | 53.1807507646287,-27.776036908842897 |
1496 | 242.7429 | 2219.4464 | 53.18734988562205,-27.792956140764467 | 9.061549e-10 | 1.759268e-10 | 1.142624e-08 | 1.957236e-09 | 2.011600e-08 | 2.873993e-09 | 3.075617e-08 | 4.204880e-09 | 4.102537e-08 | 5.608851e-09 | 28.755241 | 0.171664 | 28.141146 | 0.144993 | 27.680170 | 0.139131 | 27.367369 | 0.139131 | 27.066399 | 0.171664 | 26.452304 | 0.144993 | 25.991327 | 0.139131 | 25.678527 | 0.139131 | 1.7605 | 1.5289 | 2.6917 | True | 0.390001 | 0.857475 | 1499 | 12.578177 | 4.756119e-08 | 3.604074e-09 | 27.206868 | 0.079306 | 25.518026 | 0.079306 | 19.0 | 1.586435 | 0.901594 | 0.431686 | 32.251546 | 192.813554 | 53.18731492115171,-27.793029697701744 | 53.18743139185118,-27.792993311041542 | 53.18726693428782,-27.79290949087827 | 53.18738340487467,-27.792873104258373 |
1497 | 1133.6146 | 2222.2874 | 53.1812987152138,-27.77764037321828 | 2.574025e-09 | 3.015723e-10 | 1.386955e-08 | 2.958779e-09 | 2.673111e-08 | 4.425636e-09 | 4.410610e-08 | 6.521377e-09 | 5.883273e-08 | 8.698807e-09 | 28.544844 | 0.209947 | 27.832458 | 0.166338 | 27.288753 | 0.149719 | 26.975952 | 0.149719 | 26.856002 | 0.209947 | 26.143616 | 0.166338 | 25.599911 | 0.149719 | 25.287110 | 0.149719 | 1.9273 | 1.6500 | 3.1801 | True | 0.210654 | nan | 1501 | 20.706567 | 2.364431e-07 | 1.099639e-08 | 25.465684 | 0.049356 | 23.776841 | 0.049356 | 79.0 | 2.755657 | 2.149288 | 0.220045 | 20.415586 | 180.977594 | 53.181235144726784,-27.77779764316402 | 53.18142923873008,-27.77773700718531 | 53.181132344659446,-27.777540052575 | 53.18132643826052,-27.77747941674017 |
1498 | 1326.5419 | 2219.6143 | 53.17992467482121,-27.774343493438366 | 6.335246e-10 | 1.839624e-10 | 1.233234e-08 | 2.361181e-09 | 2.246254e-08 | 3.408373e-09 | 3.090024e-08 | 5.133305e-09 | 4.121755e-08 | 6.847269e-09 | 28.672386 | 0.190201 | 28.021353 | 0.153382 | 27.675095 | 0.166863 | 27.362294 | 0.166863 | 26.983544 | 0.190201 | 26.332511 | 0.153382 | 25.986253 | 0.166863 | 25.673452 | 0.166863 | 1.8214 | 1.3756 | 2.5056 | True | 0.301589 | 0.354939 | 1461 | 80.818695 | 3.497937e-08 | 3.550953e-09 | 27.540470 | 0.104977 | 25.851628 | 0.104977 | 13.0 | 1.187498 | 0.801002 | 0.325471 | -39.343255 | 121.218753 | 53.17989763192111,-27.774391377875908 | 53.17999467628432,-27.774361060856492 | 53.179863367306766,-27.774305514025315 | 53.17996041160292,-27.774275197029887 |
1499 | 253.7650 | 2225.5065 | 53.18739196199951,-27.79273011424997 | 1.174661e-09 | 2.296456e-10 | 1.524429e-08 | 2.559644e-09 | 2.782299e-08 | 3.705308e-09 | 4.014797e-08 | 5.469614e-09 | 5.355302e-08 | 7.295869e-09 | 28.442232 | 0.168522 | 27.788990 | 0.135742 | 27.390841 | 0.138672 | 27.078040 | 0.138672 | 26.753390 | 0.168522 | 26.100148 | 0.135742 | 25.701999 | 0.138672 | 25.389198 | 0.138672 | 1.8251 | 1.4430 | 2.6336 | True | -0.114448 | 0.423057 | 1496 | 12.578177 | 8.581226e-08 | 5.987788e-09 | 26.566127 | 0.073234 | 24.877285 | 0.073234 | 31.0 | 1.818322 | 1.273465 | 0.299648 | -88.337138 | 72.224870 | 53.18733657204453,-27.792810479100066 | 53.187511277701326,-27.79275589904614 | 53.18728858525347,-27.79269027228389 | 53.18746329074132,-27.792635692290418 |
1500 | 516.3048 | 2226.1708 | 53.18560515089531,-27.788217635834144 | 1.148776e-09 | 3.991098e-10 | 1.553034e-08 | 3.266367e-09 | 2.922723e-08 | 4.690180e-09 | nan | nan | nan | nan | 28.422047 | 0.207252 | 27.735531 | 0.161588 | nan | nan | nan | nan | 26.733205 | 0.207252 | 26.046689 | 0.161588 | nan | nan | nan | nan | 1.8819 | nan | nan | False | 0.655040 | nan | 1486 | 57.037732 | 9.148959e-08 | 7.208345e-09 | 26.496571 | 0.082341 | 24.807729 | 0.082341 | 31.0 | 1.963198 | 1.122337 | 0.428312 | 31.587262 | 192.149270 | 53.185559978363635,-27.788305234117818 | 53.185695855623,-27.78826278472429 | 53.185498286160325,-27.788150681699086 | 53.18563416325078,-27.788108232366003 |
1501 | 1113.0015 | 2224.2519 | 53.18147811591921,-27.777982444477047 | -1.609428e-10 | 2.066345e-10 | nan | nan | nan | nan | nan | nan | nan | nan | nan | nan | nan | nan | nan | nan | nan | nan | nan | nan | nan | nan | nan | nan | nan | nan | nan | nan | nan | False | nan | nan | 1497 | 20.706567 | 3.884442e-08 | 5.832449e-09 | 27.426678 | 0.151885 | 25.737836 | 0.151885 | 11.0 | 1.153065 | 0.743867 | 0.354879 | -8.752373 | 151.809636 | 53.18146125535404,-27.77803602472838 | 53.18153889310097,-27.77801177024299 | 53.18142013496442,-27.777932988568864 | 53.18149777264697,-27.7779087341065 |
1502 | 1169.5780 | 2224.3630 | 53.181092532742696,-27.77701020046973 | -1.299393e-11 | 3.936410e-10 | nan | nan | nan | nan | nan | nan | nan | nan | nan | nan | nan | nan | nan | nan | nan | nan | nan | nan | nan | nan | nan | nan | nan | nan | nan | nan | nan | False | nan | nan | 1497 | 36.023155 | 4.175702e-08 | 4.580871e-09 | 27.348176 | 0.113017 | 25.659334 | 0.113017 | 10.0 | 0.986461 | 0.699576 | 0.290823 | 2.118461 | 162.680469 | 53.18107061479781,-27.777057180721872 | 53.181148251933344,-27.777032926455178 | 53.181036348417756,-27.776971317160168 | 53.18111398549966,-27.776947062912665 |
In all likelihood, you will need to rerun Image3 with different parameters in order to return an optimal source catalog to use with your NIRISS WFSS data. You can additionally refine the source catalog so that Spec2 and Spec3 only run on the sources that you care most about. Some examples of this can be found in the NIRISS WFSS JDAT notebooks.
9. Spec2 Pipeline#
After running Image3 and thus getting the the segmentation map and source catalog, the Spec2 pipeline is ready to be run. The spec2 pipeline first runs assign_wcs, background, and flat_field corrections first on the full-frame *_rate.fits
files. The srctype step is run to determine the extent of the extraction box size before the extract_2d step is run, producing individual cutouts for the brightest 100 sources defined in the Image3 source catalog. The wfss_contam step is run towards the end of the extract_2d step and is currently not on by default as the step is being improved. The photom step is then run on the cutouts, producing flux calibrated 2-D spectral (*_cal.fits
) files. The extract_1d step is run last, producing level 2 *_x1d.fits
files.
time_spec2 = time.perf_counter()
Create Spec2 Association File#
As with the imaging part of the pipeline, there are association files for spec2. These are a bit more complex in that they need to have the science (WFSS) data, direct image, source catalog, and segmentation map included as members. For the science data, the rate files are used as inputs, similar to Image2. Also like Image2, there should be one association file for each dispersed image dither position in an observing sequence.
Like Image3, we are creating a spec2 association file manually by providing a list of exposures that we have processed through the pipeline and saved in separate directories rather than downloading directly from MAST or using the pool files. Note that the output products will have a rootname that is specified by the product_name
in the association file. For this tutorial, the rootname of the output products will end with _spec2_asn.json
.
def write_spec2asn(grismfile, dimagefiles, catalogfiles, segmfiles, prodname):
# Define the basic association of science files
asn = asn_from_list.asn_from_list([grismfile], rule=DMSLevel2bBase, product_name=prodname) # Wrap in list since input is single exposure
# Which pupil element (blocking filter) does the dispersed image use?
grism_pupil = fits.getval(grismfile, 'PUPIL')
grism_pid = fits.getval(grismfile, 'PROGRAM')
grism_obs = fits.getval(grismfile, 'OBSERVTN')
# Find the direct images with the same matching program, observation, and pupil to use
dir_img_match = []
for dir_img in dimagefiles:
img_pid = fits.getval(dir_img, 'PROGRAM')
img_obs = fits.getval(dir_img, 'OBSERVTN')
img_pupil = fits.getval(dir_img, 'PUPIL')
if img_pupil == grism_pupil and img_pid == grism_pid and img_obs == grism_obs:
dir_img_match.append(dir_img)
# ensure that there is only one match found for the grism image
if len(dir_img_match) == 0:
raise ValueError(f'Could not find a matching i2d image for {scifile}. Please ensure that you have processed the appropriate data for {grism_pupil} PID {grism_pid} o{grism_obs}')
elif len(dir_img_match) > 1:
raise ValueError(f'Multiple i2ds found matching: {grism_pupil} PID {grism_pid} o{grism_obs}. Please download the associations directly from MAST to proceed further.')
else:
# there should only be one match per filter/program/observation combination, so grab that one
dir_img_match = dir_img_match[0]
# There should be a set of i2d, segm, and cat that have the same rootname, so we will just replace the filetype suffix
dir_seg_match = dir_img_match.replace('_i2d.fits', '_segm.fits')
dir_cat_match = dir_img_match.replace('_i2d.fits', '_cat.ecsv')
# Add the direct image, catalog, and segmentation files
asn['products'][0]['members'].append({'expname': dir_img_match, 'exptype': 'direct_image'})
asn['products'][0]['members'].append({'expname': dir_cat_match, 'exptype': 'sourcecat'})
asn['products'][0]['members'].append({'expname': dir_seg_match, 'exptype': 'segmap'})
spec2_asnfile = os.path.join(sci_dir, os.path.basename(grismfile).replace('rate.fits', 'spec2_asn.json'))
# Write the association to a json file
_, serialized = asn.dump()
with open(spec2_asnfile, 'w') as outfile:
outfile.write(serialized)
print(f'Writing spec2 association: {spec2_asnfile}')
return spec2_asnfile
# find the rate files using our dataframe table that we created in the detector1 stage of the notebook
grism_rate_files = rate_dfsort[rate_dfsort['EXP_TYPE'] == 'NIS_WFSS']['PATHNAME']
print(f'Found {str(len(grism_rate_files))} grism rate files to process for level 2')
# use the rate files and image3 output products to define spec2 association files
if dospec2:
for file in grism_rate_files:
asnfile = write_spec2asn(file, image3_i2d, image3_cat, image3_segm, 'Level2')
Found 6 grism rate files to process for level 2
Writing spec2 association: /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/jw02079004003_03101_00001_nis_spec2_asn.json
Writing spec2 association: /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/jw02079004003_03101_00002_nis_spec2_asn.json
Writing spec2 association: /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/jw02079004003_03101_00003_nis_spec2_asn.json
Writing spec2 association: /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/jw02079004003_05101_00001_nis_spec2_asn.json
Writing spec2 association: /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/jw02079004003_05101_00002_nis_spec2_asn.json
Writing spec2 association: /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/jw02079004003_05101_00003_nis_spec2_asn.json
Take a quick look at the contents of an example spec2 association file to get a feel for what is being associated
if dospec2:
spec2_asns = glob.glob(os.path.join(sci_dir, "*spec2*_asn.json"))
# look at one of the association files
asn_data = json.load(open(spec2_asns[0]))
print(f'asn_type : {asn_data["asn_type"]}')
print(f'code_version : {asn_data["code_version"]}')
# in particular, take a closer look at the product filenames with the association file:
for product in asn_data['products']:
for key, value in product.items():
if key == 'members':
print(f"{key}:")
for member in value:
print(f" {member['expname']} : {member['exptype']}")
else:
print(f"{key}: {value}")
asn_type : None
code_version : 1.19.1
name: /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage1/jw02079004003_03101_00003_nis
members:
/home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage1/jw02079004003_03101_00003_nis_rate.fits : science
/home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage3_img/jw02079-o004_niriss_clear-f200w_i2d.fits : direct_image
/home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage3_img/jw02079-o004_niriss_clear-f200w_cat.ecsv : sourcecat
/home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage3_img/jw02079-o004_niriss_clear-f200w_segm.fits : segmap
Run Spec2#
In Spec2, the *_rate.fits
files run through various corrections before using the source catalog to extract the 100 brightest sources by default into 1-D spectra (level 2 *_x1d.fits
files). The parameters in each of the Spec2 steps can be modified from the default values, including overwriting reference files that are used during this stage and saving additional files. This dictionary of the modified parameters for each of the steps is then fed into the steps
parameter of the Spec2Pipeline
call. The syntax for modifying some of these parameters is below. In particular, we show the option of only extracting the 10 brightest sources by setting wfss_nbright
, as well as showing several options related to the contamination step, including turning on the step, saving the simulated images, and using additional cores to reprocess more quickly. There are several known bugs still with this stage as of pipeline version 1.19.1, so we caution use of this step currently. We also show how to save the background subtracted full-frame file as an intermediate product (*_bsub.fits). These background products are expected to be a default output in an upcoming pipeline build.
# Set up a dictionary to define how the Spec2 pipeline should be configured.
# this sets up any entry to spec2dict to be a dictionary itself
spec2dict = defaultdict(dict)
# ---------------------------Override reference files---------------------------
# Overrides for various reference files (example).
# Files should be in the base local directory or provide full path.
# spec2dict['assign_wcs']['override_distortion'] = 'myfile.asdf' # Spatial distortion (ASDF file)
# spec2dict['assign_wcs']['override_filteroffset'] = 'myfile.asdf' # Imager filter offsets (ASDF file)
# spec2dict['assign_wcs']['override_specwcs'] = 'myfile.asdf' # Spectral distortion (ASDF file)
# spec2dict['assign_wcs']['override_wavelengthrange'] = 'myfile.asdf' # Wavelength channel mapping (ASDF file)
# spec2dict['bkg_subtract']['override_bkg'] = 'myfile.fits' # WFSS Background subtraction
# spec2dict['extract_2d']['override_wavelengthrange'] = 'myfile.asdf' # Wavelength channel mapping (ASDF file)
# spec2dict['flat_field']['override_flat'] = 'myfile.fits' # Pixel flatfield
# spec2dict['wfss_contam']['override_wavelengthrange'] = 'myfile.asdf' # Wavelength channel mapping (ASDF file)
# spec2dict['wfss_contam']['override_photom'] = 'myfile.fits' # Photometric calibration array
# spec2dict['photom']['override_photom'] = 'myfile.fits' # Photometric calibration array
# -----------------------------Set step parameters------------------------------
# Overrides for whether or not certain steps should be skipped (example).
# spec2dict['bkg_subtract']['skip'] = True # don't perform the background subtraction
# spec2dict['bkg_subtract']['save_results'] = True # save background subtracted full-frame images
# spec2dict['flat_field']['save_results'] = True # save the background subtracted, flat-field corrected, full-frame images
# spec2dict['extract_2d']['wfss_nbright'] = 10 # only extract the 10 brightest sources
# spec2dict['wfss_contam']['skip'] = False # uncomment to turn on contamination correction
# spec2dict['wfss_contam']['save_simulated_image'] = True # save the simulated images produced by the pipeline
# spec2dict['wfss_contam']['maximum_cores'] = 'half' # (quarter, half, all, or the default=1); This will speed up the calibration time
if dospec2:
for spec2_asn in spec2_asns:
os.chdir(image3_dir) # This is necessary since the pipeline looks in the current directory for the catalog
spec2 = Spec2Pipeline.call(spec2_asn, steps=spec2dict, save_results=True, output_dir=spec2_dir)
os.chdir(cwd) # change back into your original directory
else:
print('Skipping Spec2 processing for SCI data')
2025-09-13 16:29:49,536 - CRDS - INFO - Fetching /home/runner/crds/references/jwst/niriss/jwst_niriss_pars-spec2pipeline_0005.asdf 1.5 K bytes (1 / 1 files) (0 / 1.5 K bytes)
2025-09-13 16:29:49,782 - stpipe - INFO - PARS-SPEC2PIPELINE parameters found: /home/runner/crds/references/jwst/niriss/jwst_niriss_pars-spec2pipeline_0005.asdf
2025-09-13 16:29:49,804 - stpipe.Spec2Pipeline - INFO - Spec2Pipeline instance created.
2025-09-13 16:29:49,805 - stpipe.Spec2Pipeline.assign_wcs - INFO - AssignWcsStep instance created.
2025-09-13 16:29:49,806 - stpipe.Spec2Pipeline.badpix_selfcal - INFO - BadpixSelfcalStep instance created.
2025-09-13 16:29:49,807 - stpipe.Spec2Pipeline.msa_flagging - INFO - MSAFlagOpenStep instance created.
2025-09-13 16:29:49,808 - stpipe.Spec2Pipeline.nsclean - INFO - NSCleanStep instance created.
2025-09-13 16:29:49,809 - stpipe.Spec2Pipeline.bkg_subtract - INFO - BackgroundStep instance created.
2025-09-13 16:29:49,810 - stpipe.Spec2Pipeline.imprint_subtract - INFO - ImprintStep instance created.
2025-09-13 16:29:49,810 - stpipe.Spec2Pipeline.extract_2d - INFO - Extract2dStep instance created.
2025-09-13 16:29:49,815 - stpipe.Spec2Pipeline.master_background_mos - INFO - MasterBackgroundMosStep instance created.
2025-09-13 16:29:49,816 - stpipe.Spec2Pipeline.master_background_mos.flat_field - INFO - FlatFieldStep instance created.
2025-09-13 16:29:49,817 - stpipe.Spec2Pipeline.master_background_mos.pathloss - INFO - PathLossStep instance created.
2025-09-13 16:29:49,817 - stpipe.Spec2Pipeline.master_background_mos.barshadow - INFO - BarShadowStep instance created.
2025-09-13 16:29:49,818 - stpipe.Spec2Pipeline.master_background_mos.photom - INFO - PhotomStep instance created.
2025-09-13 16:29:49,819 - stpipe.Spec2Pipeline.master_background_mos.pixel_replace - INFO - PixelReplaceStep instance created.
2025-09-13 16:29:49,820 - stpipe.Spec2Pipeline.master_background_mos.resample_spec - INFO - ResampleSpecStep instance created.
2025-09-13 16:29:49,821 - stpipe.Spec2Pipeline.master_background_mos.extract_1d - INFO - Extract1dStep instance created.
2025-09-13 16:29:49,822 - stpipe.Spec2Pipeline.wavecorr - INFO - WavecorrStep instance created.
2025-09-13 16:29:49,823 - stpipe.Spec2Pipeline.flat_field - INFO - FlatFieldStep instance created.
2025-09-13 16:29:49,823 - stpipe.Spec2Pipeline.srctype - INFO - SourceTypeStep instance created.
2025-09-13 16:29:49,824 - stpipe.Spec2Pipeline.straylight - INFO - StraylightStep instance created.
2025-09-13 16:29:49,825 - stpipe.Spec2Pipeline.fringe - INFO - FringeStep instance created.
2025-09-13 16:29:49,825 - stpipe.Spec2Pipeline.residual_fringe - INFO - ResidualFringeStep instance created.
2025-09-13 16:29:49,826 - stpipe.Spec2Pipeline.pathloss - INFO - PathLossStep instance created.
2025-09-13 16:29:49,827 - stpipe.Spec2Pipeline.barshadow - INFO - BarShadowStep instance created.
2025-09-13 16:29:49,828 - stpipe.Spec2Pipeline.wfss_contam - INFO - WfssContamStep instance created.
2025-09-13 16:29:49,828 - stpipe.Spec2Pipeline.photom - INFO - PhotomStep instance created.
2025-09-13 16:29:49,829 - stpipe.Spec2Pipeline.pixel_replace - INFO - PixelReplaceStep instance created.
2025-09-13 16:29:49,830 - stpipe.Spec2Pipeline.resample_spec - INFO - ResampleSpecStep instance created.
2025-09-13 16:29:49,832 - stpipe.Spec2Pipeline.cube_build - INFO - CubeBuildStep instance created.
2025-09-13 16:29:49,833 - stpipe.Spec2Pipeline.extract_1d - INFO - Extract1dStep instance created.
2025-09-13 16:29:50,080 - stpipe.Spec2Pipeline - INFO - Step Spec2Pipeline running with args ('/home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/jw02079004003_03101_00003_nis_spec2_asn.json',).
2025-09-13 16:29:50,116 - stpipe.Spec2Pipeline - INFO - Step Spec2Pipeline parameters are:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage2_spec
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: True
skip: False
suffix: None
search_output_file: True
input_dir: ''
save_bsub: False
fail_on_exception: True
save_wfss_esec: False
steps:
assign_wcs:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
sip_approx: True
sip_max_pix_error: 0.01
sip_degree: None
sip_max_inv_pix_error: 0.01
sip_inv_degree: None
sip_npoints: 12
slit_y_low: -0.55
slit_y_high: 0.55
nrs_ifu_slice_wcs: False
badpix_selfcal:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: True
suffix: None
search_output_file: True
input_dir: ''
flagfrac_lower: 0.001
flagfrac_upper: 0.001
kernel_size: 15
force_single: False
save_flagged_bkg: False
msa_flagging:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
nsclean:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: True
suffix: None
search_output_file: True
input_dir: ''
fit_method: fft
fit_by_channel: False
background_method: None
background_box_size: None
mask_spectral_regions: True
n_sigma: 5.0
fit_histogram: False
single_mask: False
user_mask: None
save_mask: False
save_background: False
save_noise: False
bkg_subtract:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
bkg_list: None
save_combined_background: False
sigma: 3.0
maxiters: None
soss_source_percentile: 35.0
soss_bkg_percentile: None
wfss_mmag_extract: None
wfss_maxiter: 5
wfss_rms_stop: 0.0
wfss_outlier_percent: 1.0
imprint_subtract:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
extract_2d:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
slit_names: None
source_ids: None
extract_orders: None
grism_objects: None
tsgrism_extract_height: None
wfss_extract_half_height: 5
wfss_mmag_extract: None
wfss_nbright: 100
master_background_mos:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: True
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
sigma_clip: 3.0
median_kernel: 1
force_subtract: False
save_background: False
user_background: None
inverse: False
steps:
flat_field:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
save_interpolated_flat: False
user_supplied_flat: None
inverse: False
pathloss:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
inverse: False
source_type: None
user_slit_loc: None
barshadow:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
inverse: False
source_type: None
photom:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
inverse: False
source_type: None
mrs_time_correction: True
pixel_replace:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: True
output_use_index: True
save_results: False
skip: True
suffix: None
search_output_file: True
input_dir: ''
algorithm: fit_profile
n_adjacent_cols: 3
resample_spec:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
pixfrac: 1.0
kernel: square
fillval: NAN
weight_type: ivm
output_shape: None
pixel_scale_ratio: 1.0
pixel_scale: None
output_wcs: ''
single: False
blendheaders: True
in_memory: True
extract_1d:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
subtract_background: None
apply_apcorr: True
extraction_type: box
use_source_posn: None
position_offset: 0.0
model_nod_pair: True
optimize_psf_location: True
smoothing_length: None
bkg_fit: None
bkg_order: None
log_increment: 50
save_profile: False
save_scene_model: False
save_residual_image: False
center_xy: None
ifu_autocen: False
bkg_sigma_clip: 3.0
ifu_rfcorr: True
ifu_set_srctype: None
ifu_rscale: None
ifu_covar_scale: 1.0
soss_atoca: True
soss_threshold: 0.01
soss_n_os: 2
soss_wave_grid_in: None
soss_wave_grid_out: None
soss_estimate: None
soss_rtol: 0.0001
soss_max_grid_size: 20000
soss_tikfac: None
soss_width: 40.0
soss_bad_pix: masking
soss_modelname: None
wavecorr:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
flat_field:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
save_interpolated_flat: False
user_supplied_flat: None
inverse: False
srctype:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
source_type: None
straylight:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
clean_showers: False
shower_plane: 3
shower_x_stddev: 18.0
shower_y_stddev: 5.0
shower_low_reject: 0.1
shower_high_reject: 99.9
save_shower_model: False
fringe:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
residual_fringe:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: True
suffix: residual_fringe
search_output_file: False
input_dir: ''
save_intermediate_results: False
ignore_region_min: None
ignore_region_max: None
pathloss:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
inverse: False
source_type: None
user_slit_loc: None
barshadow:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
inverse: False
source_type: None
wfss_contam:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: True
suffix: None
search_output_file: True
input_dir: ''
save_simulated_image: False
save_contam_images: False
maximum_cores: none
photom:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
inverse: False
source_type: None
mrs_time_correction: True
pixel_replace:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: True
output_use_index: True
save_results: False
skip: True
suffix: None
search_output_file: True
input_dir: ''
algorithm: fit_profile
n_adjacent_cols: 3
resample_spec:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
pixfrac: 1.0
kernel: square
fillval: NAN
weight_type: ivm
output_shape: None
pixel_scale_ratio: 1.0
pixel_scale: None
output_wcs: ''
single: False
blendheaders: True
in_memory: True
cube_build:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: True
output_use_index: True
save_results: False
skip: False
suffix: s3d
search_output_file: False
input_dir: ''
channel: all
band: all
grating: all
filter: all
output_type: None
scalexy: 0.0
scalew: 0.0
weighting: drizzle
coord_system: skyalign
ra_center: None
dec_center: None
cube_pa: None
nspax_x: None
nspax_y: None
rois: 0.0
roiw: 0.0
weight_power: 2.0
wavemin: None
wavemax: None
single: False
skip_dqflagging: False
offset_file: None
debug_spaxel: -1 -1 -1
extract_1d:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
subtract_background: None
apply_apcorr: True
extraction_type: box
use_source_posn: None
position_offset: 0.0
model_nod_pair: True
optimize_psf_location: True
smoothing_length: None
bkg_fit: None
bkg_order: None
log_increment: 50
save_profile: False
save_scene_model: False
save_residual_image: False
center_xy: None
ifu_autocen: False
bkg_sigma_clip: 3.0
ifu_rfcorr: True
ifu_set_srctype: None
ifu_rscale: None
ifu_covar_scale: 1.0
soss_atoca: True
soss_threshold: 0.01
soss_n_os: 2
soss_wave_grid_in: None
soss_wave_grid_out: None
soss_estimate: None
soss_rtol: 0.0001
soss_max_grid_size: 20000
soss_tikfac: None
soss_width: 40.0
soss_bad_pix: masking
soss_modelname: None
2025-09-13 16:29:50,161 - stpipe.Spec2Pipeline - INFO - Prefetching reference files for dataset: 'jw02079004003_03101_00003_nis_spec2_asn.json' reftypes = ['apcorr', 'area', 'barshadow', 'bkg', 'camera', 'collimator', 'cubepar', 'dflat', 'disperser', 'distortion', 'extract1d', 'fflat', 'filteroffset', 'flat', 'fore', 'fpa', 'fringe', 'ifufore', 'ifupost', 'ifuslicer', 'mrsxartcorr', 'msa', 'msaoper', 'ote', 'pastasoss', 'pathloss', 'photom', 'psf', 'regions', 'sflat', 'speckernel', 'specprofile', 'specwcs', 'wavecorr', 'wavelengthrange']
2025-09-13 16:29:50,165 - CRDS - INFO - Fetching /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits 20.2 K bytes (1 / 6 files) (0 / 154.7 M bytes)
2025-09-13 16:29:50,488 - CRDS - INFO - Fetching /home/runner/crds/references/jwst/niriss/jwst_niriss_bkg_0029.fits 83.9 M bytes (2 / 6 files) (20.2 K / 154.7 M bytes)
2025-09-13 16:31:54,641 - CRDS - INFO - Fetching /home/runner/crds/references/jwst/niriss/jwst_niriss_flat_0271.fits 67.1 M bytes (3 / 6 files) (83.9 M / 154.7 M bytes)
2025-09-13 16:33:45,535 - CRDS - INFO - Fetching /home/runner/crds/references/jwst/niriss/jwst_niriss_photom_0041.fits 3.6 M bytes (4 / 6 files) (151.1 M / 154.7 M bytes)
2025-09-13 16:33:51,475 - CRDS - INFO - Fetching /home/runner/crds/references/jwst/niriss/jwst_niriss_specwcs_0065.asdf 20.6 K bytes (5 / 6 files) (154.7 M / 154.7 M bytes)
2025-09-13 16:33:51,793 - CRDS - INFO - Fetching /home/runner/crds/references/jwst/niriss/jwst_niriss_wavelengthrange_0002.asdf 2.4 K bytes (6 / 6 files) (154.7 M / 154.7 M bytes)
2025-09-13 16:33:52,050 - stpipe.Spec2Pipeline - INFO - Prefetch for APCORR reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits'.
2025-09-13 16:33:52,051 - stpipe.Spec2Pipeline - INFO - Prefetch for AREA reference file is 'N/A'.
2025-09-13 16:33:52,051 - stpipe.Spec2Pipeline - INFO - Prefetch for BARSHADOW reference file is 'N/A'.
2025-09-13 16:33:52,052 - stpipe.Spec2Pipeline - INFO - Prefetch for BKG reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_bkg_0029.fits'.
2025-09-13 16:33:52,052 - stpipe.Spec2Pipeline - INFO - Prefetch for CAMERA reference file is 'N/A'.
2025-09-13 16:33:52,052 - stpipe.Spec2Pipeline - INFO - Prefetch for COLLIMATOR reference file is 'N/A'.
2025-09-13 16:33:52,053 - stpipe.Spec2Pipeline - INFO - Prefetch for CUBEPAR reference file is 'N/A'.
2025-09-13 16:33:52,053 - stpipe.Spec2Pipeline - INFO - Prefetch for DFLAT reference file is 'N/A'.
2025-09-13 16:33:52,054 - stpipe.Spec2Pipeline - INFO - Prefetch for DISPERSER reference file is 'N/A'.
2025-09-13 16:33:52,054 - stpipe.Spec2Pipeline - INFO - Prefetch for DISTORTION reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_distortion_0037.asdf'.
2025-09-13 16:33:52,054 - stpipe.Spec2Pipeline - INFO - Prefetch for EXTRACT1D reference file is 'N/A'.
2025-09-13 16:33:52,055 - stpipe.Spec2Pipeline - INFO - Prefetch for FFLAT reference file is 'N/A'.
2025-09-13 16:33:52,055 - stpipe.Spec2Pipeline - INFO - Prefetch for FILTEROFFSET reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_filteroffset_0006.asdf'.
2025-09-13 16:33:52,056 - stpipe.Spec2Pipeline - INFO - Prefetch for FLAT reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_flat_0271.fits'.
2025-09-13 16:33:52,056 - stpipe.Spec2Pipeline - INFO - Prefetch for FORE reference file is 'N/A'.
2025-09-13 16:33:52,056 - stpipe.Spec2Pipeline - INFO - Prefetch for FPA reference file is 'N/A'.
2025-09-13 16:33:52,056 - stpipe.Spec2Pipeline - INFO - Prefetch for FRINGE reference file is 'N/A'.
2025-09-13 16:33:52,057 - stpipe.Spec2Pipeline - INFO - Prefetch for IFUFORE reference file is 'N/A'.
2025-09-13 16:33:52,057 - stpipe.Spec2Pipeline - INFO - Prefetch for IFUPOST reference file is 'N/A'.
2025-09-13 16:33:52,057 - stpipe.Spec2Pipeline - INFO - Prefetch for IFUSLICER reference file is 'N/A'.
2025-09-13 16:33:52,058 - stpipe.Spec2Pipeline - INFO - Prefetch for MRSXARTCORR reference file is 'N/A'.
2025-09-13 16:33:52,058 - stpipe.Spec2Pipeline - INFO - Prefetch for MSA reference file is 'N/A'.
2025-09-13 16:33:52,058 - stpipe.Spec2Pipeline - INFO - Prefetch for MSAOPER reference file is 'N/A'.
2025-09-13 16:33:52,059 - stpipe.Spec2Pipeline - INFO - Prefetch for OTE reference file is 'N/A'.
2025-09-13 16:33:52,059 - stpipe.Spec2Pipeline - INFO - Prefetch for PASTASOSS reference file is 'N/A'.
2025-09-13 16:33:52,059 - stpipe.Spec2Pipeline - INFO - Prefetch for PATHLOSS reference file is 'N/A'.
2025-09-13 16:33:52,059 - stpipe.Spec2Pipeline - INFO - Prefetch for PHOTOM reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_photom_0041.fits'.
2025-09-13 16:33:52,060 - stpipe.Spec2Pipeline - INFO - Prefetch for PSF reference file is 'N/A'.
2025-09-13 16:33:52,060 - stpipe.Spec2Pipeline - INFO - Prefetch for REGIONS reference file is 'N/A'.
2025-09-13 16:33:52,061 - stpipe.Spec2Pipeline - INFO - Prefetch for SFLAT reference file is 'N/A'.
2025-09-13 16:33:52,061 - stpipe.Spec2Pipeline - INFO - Prefetch for SPECKERNEL reference file is 'N/A'.
2025-09-13 16:33:52,061 - stpipe.Spec2Pipeline - INFO - Prefetch for SPECPROFILE reference file is 'N/A'.
2025-09-13 16:33:52,061 - stpipe.Spec2Pipeline - INFO - Prefetch for SPECWCS reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_specwcs_0065.asdf'.
2025-09-13 16:33:52,062 - stpipe.Spec2Pipeline - INFO - Prefetch for WAVECORR reference file is 'N/A'.
2025-09-13 16:33:52,062 - stpipe.Spec2Pipeline - INFO - Prefetch for WAVELENGTHRANGE reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_wavelengthrange_0002.asdf'.
2025-09-13 16:33:52,063 - stpipe.Spec2Pipeline - INFO - Starting calwebb_spec2 ...
2025-09-13 16:33:52,070 - stpipe.Spec2Pipeline - INFO - Processing product /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage1/jw02079004003_03101_00003_nis
2025-09-13 16:33:52,070 - stpipe.Spec2Pipeline - INFO - Working on input /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage1/jw02079004003_03101_00003_nis_rate.fits ...
2025-09-13 16:33:52,118 - stpipe.Spec2Pipeline - INFO - Using sourcecat file jw02079-o004_niriss_clear-f200w_cat.ecsv
2025-09-13 16:33:52,119 - stpipe.Spec2Pipeline - INFO - Using segmentation map jw02079-o004_niriss_clear-f200w_segm.fits
2025-09-13 16:33:52,119 - stpipe.Spec2Pipeline - INFO - Using direct image jw02079-o004_niriss_clear-f200w_i2d.fits
2025-09-13 16:33:52,348 - stpipe.Spec2Pipeline.assign_wcs - INFO - Step assign_wcs running with args (<ImageModel(2048, 2048) from jw02079004003_03101_00003_nis_rate.fits>,).
2025-09-13 16:33:52,463 - jwst.assign_wcs.niriss - INFO - Added Barycentric velocity correction: 0.9999282763888806
2025-09-13 16:33:52,521 - jwst.assign_wcs.niriss - INFO - Offsets from filteroffset file are 2.119, -1.0476
2025-09-13 16:33:52,603 - jwst.assign_wcs.assign_wcs - INFO - COMPLETED assign_wcs
2025-09-13 16:33:52,604 - stpipe.AssignWcsStep - INFO - AssignWcsStep instance created.
2025-09-13 16:33:52,681 - jwst.assign_wcs.niriss - INFO - Offsets from filteroffset file are 2.119, -1.0476
2025-09-13 16:33:52,729 - stpipe.Spec2Pipeline.assign_wcs - INFO - Step assign_wcs done
2025-09-13 16:33:52,964 - stpipe.Spec2Pipeline.badpix_selfcal - INFO - Step badpix_selfcal running with args (<ImageModel(2048, 2048) from jw02079004003_03101_00003_nis_rate.fits>, [], []).
2025-09-13 16:33:52,964 - stpipe.Spec2Pipeline.badpix_selfcal - INFO - Step skipped.
2025-09-13 16:33:53,193 - stpipe.Spec2Pipeline.msa_flagging - INFO - Step msa_flagging running with args (<ImageModel(2048, 2048) from jw02079004003_03101_00003_nis_rate.fits>,).
2025-09-13 16:33:53,193 - stpipe.Spec2Pipeline.msa_flagging - INFO - Step skipped.
2025-09-13 16:33:53,421 - stpipe.Spec2Pipeline.nsclean - INFO - Step nsclean running with args (<ImageModel(2048, 2048) from jw02079004003_03101_00003_nis_rate.fits>,).
2025-09-13 16:33:53,422 - stpipe.Spec2Pipeline.nsclean - INFO - Step skipped.
2025-09-13 16:33:53,650 - stpipe.Spec2Pipeline.imprint_subtract - INFO - Step imprint_subtract running with args (<ImageModel(2048, 2048) from jw02079004003_03101_00003_nis_rate.fits>, []).
2025-09-13 16:33:53,650 - stpipe.Spec2Pipeline.imprint_subtract - INFO - Step skipped.
2025-09-13 16:33:53,880 - stpipe.Spec2Pipeline.bkg_subtract - INFO - Step bkg_subtract running with args (<ImageModel(2048, 2048) from jw02079004003_03101_00003_nis_rate.fits>, []).
2025-09-13 16:33:54,145 - jwst.background.asn_intake - INFO - Working on input <ImageModel(2048, 2048) from jw02079004003_03101_00003_nis_rate.fits> ...
2025-09-13 16:33:54,461 - stpipe.Spec2Pipeline.bkg_subtract - INFO - Using BKG reference file /home/runner/crds/references/jwst/niriss/jwst_niriss_bkg_0029.fits
2025-09-13 16:33:54,462 - stpipe.Spec2Pipeline.bkg_subtract - INFO - Using WavelengthRange reference file /home/runner/crds/references/jwst/niriss/jwst_niriss_wavelengthrange_0002.asdf
2025-09-13 16:33:54,529 - jwst.assign_wcs.util - INFO - Getting objects from jw02079-o004_niriss_clear-f200w_cat.ecsv
2025-09-13 16:33:54,828 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1, order 1
2025-09-13 16:33:54,840 - jwst.assign_wcs.util - INFO - Excluding off-image object: 2, order 1
2025-09-13 16:33:54,853 - jwst.assign_wcs.util - INFO - Excluding off-image object: 3, order 1
2025-09-13 16:33:54,865 - jwst.assign_wcs.util - INFO - Excluding off-image object: 4, order 1
2025-09-13 16:33:54,878 - jwst.assign_wcs.util - INFO - Excluding off-image object: 5, order 1
2025-09-13 16:33:54,890 - jwst.assign_wcs.util - INFO - Excluding off-image object: 6, order 1
2025-09-13 16:33:54,903 - jwst.assign_wcs.util - INFO - Excluding off-image object: 7, order 1
2025-09-13 16:33:54,916 - jwst.assign_wcs.util - INFO - Excluding off-image object: 8, order 1
2025-09-13 16:33:54,928 - jwst.assign_wcs.util - INFO - Excluding off-image object: 9, order 1
2025-09-13 16:33:54,941 - jwst.assign_wcs.util - INFO - Excluding off-image object: 10, order 1
2025-09-13 16:33:54,954 - jwst.assign_wcs.util - INFO - Excluding off-image object: 11, order 1
2025-09-13 16:33:54,967 - jwst.assign_wcs.util - INFO - Excluding off-image object: 12, order 1
2025-09-13 16:33:54,979 - jwst.assign_wcs.util - INFO - Excluding off-image object: 13, order 1
2025-09-13 16:33:54,992 - jwst.assign_wcs.util - INFO - Excluding off-image object: 14, order 1
2025-09-13 16:33:55,005 - jwst.assign_wcs.util - INFO - Excluding off-image object: 15, order 1
2025-09-13 16:33:55,017 - jwst.assign_wcs.util - INFO - Excluding off-image object: 16, order 1
2025-09-13 16:33:55,030 - jwst.assign_wcs.util - INFO - Excluding off-image object: 17, order 1
2025-09-13 16:33:55,043 - jwst.assign_wcs.util - INFO - Excluding off-image object: 18, order 1
2025-09-13 16:33:55,055 - jwst.assign_wcs.util - INFO - Excluding off-image object: 19, order 1
2025-09-13 16:33:55,067 - jwst.assign_wcs.util - INFO - Excluding off-image object: 20, order 1
2025-09-13 16:33:55,081 - jwst.assign_wcs.util - INFO - Excluding off-image object: 21, order 1
2025-09-13 16:33:55,094 - jwst.assign_wcs.util - INFO - Excluding off-image object: 22, order 1
2025-09-13 16:33:55,106 - jwst.assign_wcs.util - INFO - Excluding off-image object: 23, order 1
2025-09-13 16:33:55,118 - jwst.assign_wcs.util - INFO - Excluding off-image object: 24, order 1
2025-09-13 16:33:55,131 - jwst.assign_wcs.util - INFO - Excluding off-image object: 25, order 1
2025-09-13 16:33:55,143 - jwst.assign_wcs.util - INFO - Excluding off-image object: 26, order 1
2025-09-13 16:33:55,156 - jwst.assign_wcs.util - INFO - Excluding off-image object: 27, order 1
2025-09-13 16:33:55,168 - jwst.assign_wcs.util - INFO - Excluding off-image object: 28, order 1
2025-09-13 16:33:55,181 - jwst.assign_wcs.util - INFO - Excluding off-image object: 29, order 1
2025-09-13 16:33:55,193 - jwst.assign_wcs.util - INFO - Excluding off-image object: 30, order 1
2025-09-13 16:33:55,206 - jwst.assign_wcs.util - INFO - Excluding off-image object: 31, order 1
2025-09-13 16:33:55,218 - jwst.assign_wcs.util - INFO - Excluding off-image object: 32, order 1
2025-09-13 16:33:55,230 - jwst.assign_wcs.util - INFO - Excluding off-image object: 33, order 1
2025-09-13 16:33:55,242 - jwst.assign_wcs.util - INFO - Excluding off-image object: 34, order 1
2025-09-13 16:33:55,255 - jwst.assign_wcs.util - INFO - Excluding off-image object: 35, order 1
2025-09-13 16:33:55,268 - jwst.assign_wcs.util - INFO - Excluding off-image object: 36, order 1
2025-09-13 16:33:55,281 - jwst.assign_wcs.util - INFO - Excluding off-image object: 37, order 1
2025-09-13 16:33:55,293 - jwst.assign_wcs.util - INFO - Excluding off-image object: 38, order 1
2025-09-13 16:33:55,305 - jwst.assign_wcs.util - INFO - Excluding off-image object: 39, order 1
2025-09-13 16:33:55,318 - jwst.assign_wcs.util - INFO - Excluding off-image object: 40, order 1
2025-09-13 16:33:55,331 - jwst.assign_wcs.util - INFO - Excluding off-image object: 41, order 1
2025-09-13 16:33:55,343 - jwst.assign_wcs.util - INFO - Excluding off-image object: 42, order 1
2025-09-13 16:33:55,355 - jwst.assign_wcs.util - INFO - Excluding off-image object: 43, order 1
2025-09-13 16:33:55,368 - jwst.assign_wcs.util - INFO - Excluding off-image object: 44, order 1
2025-09-13 16:33:55,381 - jwst.assign_wcs.util - INFO - Excluding off-image object: 45, order 1
2025-09-13 16:33:55,393 - jwst.assign_wcs.util - INFO - Excluding off-image object: 46, order 1
2025-09-13 16:33:55,405 - jwst.assign_wcs.util - INFO - Excluding off-image object: 47, order 1
2025-09-13 16:33:55,418 - jwst.assign_wcs.util - INFO - Excluding off-image object: 48, order 1
2025-09-13 16:33:55,430 - jwst.assign_wcs.util - INFO - Excluding off-image object: 49, order 1
2025-09-13 16:33:55,443 - jwst.assign_wcs.util - INFO - Excluding off-image object: 50, order 1
2025-09-13 16:33:55,456 - jwst.assign_wcs.util - INFO - Excluding off-image object: 51, order 1
2025-09-13 16:33:55,468 - jwst.assign_wcs.util - INFO - Excluding off-image object: 52, order 1
2025-09-13 16:33:55,481 - jwst.assign_wcs.util - INFO - Excluding off-image object: 53, order 1
2025-09-13 16:33:55,493 - jwst.assign_wcs.util - INFO - Excluding off-image object: 54, order 1
2025-09-13 16:33:55,505 - jwst.assign_wcs.util - INFO - Excluding off-image object: 55, order 1
2025-09-13 16:33:55,517 - jwst.assign_wcs.util - INFO - Excluding off-image object: 56, order 1
2025-09-13 16:33:55,530 - jwst.assign_wcs.util - INFO - Excluding off-image object: 57, order 1
2025-09-13 16:33:55,542 - jwst.assign_wcs.util - INFO - Excluding off-image object: 58, order 1
2025-09-13 16:33:55,554 - jwst.assign_wcs.util - INFO - Excluding off-image object: 59, order 1
2025-09-13 16:33:55,567 - jwst.assign_wcs.util - INFO - Excluding off-image object: 60, order 1
2025-09-13 16:33:55,581 - jwst.assign_wcs.util - INFO - Excluding off-image object: 61, order 1
2025-09-13 16:33:55,593 - jwst.assign_wcs.util - INFO - Excluding off-image object: 62, order 1
2025-09-13 16:33:55,606 - jwst.assign_wcs.util - INFO - Excluding off-image object: 63, order 1
2025-09-13 16:33:55,618 - jwst.assign_wcs.util - INFO - Excluding off-image object: 64, order 1
2025-09-13 16:33:55,631 - jwst.assign_wcs.util - INFO - Excluding off-image object: 65, order 1
2025-09-13 16:33:55,643 - jwst.assign_wcs.util - INFO - Excluding off-image object: 66, order 1
2025-09-13 16:33:55,656 - jwst.assign_wcs.util - INFO - Excluding off-image object: 67, order 1
2025-09-13 16:33:55,668 - jwst.assign_wcs.util - INFO - Excluding off-image object: 68, order 1
2025-09-13 16:33:55,680 - jwst.assign_wcs.util - INFO - Excluding off-image object: 69, order 1
2025-09-13 16:33:55,693 - jwst.assign_wcs.util - INFO - Excluding off-image object: 70, order 1
2025-09-13 16:33:55,705 - jwst.assign_wcs.util - INFO - Excluding off-image object: 71, order 1
2025-09-13 16:33:55,718 - jwst.assign_wcs.util - INFO - Excluding off-image object: 72, order 1
2025-09-13 16:33:55,730 - jwst.assign_wcs.util - INFO - Excluding off-image object: 73, order 1
2025-09-13 16:33:55,742 - jwst.assign_wcs.util - INFO - Excluding off-image object: 74, order 1
2025-09-13 16:33:55,754 - jwst.assign_wcs.util - INFO - Excluding off-image object: 75, order 1
2025-09-13 16:33:55,767 - jwst.assign_wcs.util - INFO - Excluding off-image object: 76, order 1
2025-09-13 16:33:55,779 - jwst.assign_wcs.util - INFO - Excluding off-image object: 77, order 1
2025-09-13 16:33:55,792 - jwst.assign_wcs.util - INFO - Excluding off-image object: 78, order 1
2025-09-13 16:33:55,804 - jwst.assign_wcs.util - INFO - Excluding off-image object: 79, order 1
2025-09-13 16:33:55,817 - jwst.assign_wcs.util - INFO - Excluding off-image object: 80, order 1
2025-09-13 16:33:55,830 - jwst.assign_wcs.util - INFO - Excluding off-image object: 81, order 1
2025-09-13 16:33:55,842 - jwst.assign_wcs.util - INFO - Excluding off-image object: 82, order 1
2025-09-13 16:33:55,855 - jwst.assign_wcs.util - INFO - Excluding off-image object: 83, order 1
2025-09-13 16:33:55,867 - jwst.assign_wcs.util - INFO - Excluding off-image object: 84, order 1
2025-09-13 16:33:55,879 - jwst.assign_wcs.util - INFO - Excluding off-image object: 85, order 1
2025-09-13 16:33:55,895 - jwst.assign_wcs.util - INFO - Excluding off-image object: 86, order 1
2025-09-13 16:33:55,910 - jwst.assign_wcs.util - INFO - Excluding off-image object: 87, order 1
2025-09-13 16:33:55,925 - jwst.assign_wcs.util - INFO - Excluding off-image object: 88, order 1
2025-09-13 16:33:55,938 - jwst.assign_wcs.util - INFO - Excluding off-image object: 89, order 1
2025-09-13 16:33:55,951 - jwst.assign_wcs.util - INFO - Excluding off-image object: 90, order 1
2025-09-13 16:33:55,964 - jwst.assign_wcs.util - INFO - Excluding off-image object: 91, order 1
2025-09-13 16:33:55,977 - jwst.assign_wcs.util - INFO - Excluding off-image object: 92, order 1
2025-09-13 16:33:55,989 - jwst.assign_wcs.util - INFO - Excluding off-image object: 93, order 1
2025-09-13 16:33:56,002 - jwst.assign_wcs.util - INFO - Excluding off-image object: 94, order 1
2025-09-13 16:33:56,014 - jwst.assign_wcs.util - INFO - Excluding off-image object: 95, order 1
2025-09-13 16:33:56,027 - jwst.assign_wcs.util - INFO - Excluding off-image object: 96, order 1
2025-09-13 16:33:56,039 - jwst.assign_wcs.util - INFO - Excluding off-image object: 97, order 1
2025-09-13 16:33:56,052 - jwst.assign_wcs.util - INFO - Excluding off-image object: 98, order 1
2025-09-13 16:33:56,064 - jwst.assign_wcs.util - INFO - Excluding off-image object: 99, order 1
2025-09-13 16:33:56,081 - jwst.assign_wcs.util - INFO - Excluding off-image object: 100, order 1
2025-09-13 16:33:56,094 - jwst.assign_wcs.util - INFO - Excluding off-image object: 101, order 1
2025-09-13 16:33:56,106 - jwst.assign_wcs.util - INFO - Excluding off-image object: 102, order 1
2025-09-13 16:33:56,119 - jwst.assign_wcs.util - INFO - Excluding off-image object: 103, order 1
2025-09-13 16:33:56,131 - jwst.assign_wcs.util - INFO - Excluding off-image object: 104, order 1
2025-09-13 16:33:56,144 - jwst.assign_wcs.util - INFO - Excluding off-image object: 105, order 1
2025-09-13 16:33:56,156 - jwst.assign_wcs.util - INFO - Excluding off-image object: 106, order 1
2025-09-13 16:33:56,170 - jwst.assign_wcs.util - INFO - Excluding off-image object: 107, order 1
2025-09-13 16:33:56,182 - jwst.assign_wcs.util - INFO - Excluding off-image object: 108, order 1
2025-09-13 16:33:56,194 - jwst.assign_wcs.util - INFO - Excluding off-image object: 109, order 1
2025-09-13 16:33:56,207 - jwst.assign_wcs.util - INFO - Excluding off-image object: 110, order 1
2025-09-13 16:33:56,219 - jwst.assign_wcs.util - INFO - Excluding off-image object: 111, order 1
2025-09-13 16:33:56,232 - jwst.assign_wcs.util - INFO - Excluding off-image object: 112, order 1
2025-09-13 16:33:56,245 - jwst.assign_wcs.util - INFO - Excluding off-image object: 113, order 1
2025-09-13 16:33:56,257 - jwst.assign_wcs.util - INFO - Excluding off-image object: 114, order 1
2025-09-13 16:33:56,270 - jwst.assign_wcs.util - INFO - Excluding off-image object: 115, order 1
2025-09-13 16:33:56,282 - jwst.assign_wcs.util - INFO - Excluding off-image object: 116, order 1
2025-09-13 16:33:56,295 - jwst.assign_wcs.util - INFO - Excluding off-image object: 117, order 1
2025-09-13 16:33:56,308 - jwst.assign_wcs.util - INFO - Excluding off-image object: 118, order 1
2025-09-13 16:33:56,320 - jwst.assign_wcs.util - INFO - Excluding off-image object: 119, order 1
2025-09-13 16:33:56,333 - jwst.assign_wcs.util - INFO - Excluding off-image object: 120, order 1
2025-09-13 16:33:56,345 - jwst.assign_wcs.util - INFO - Excluding off-image object: 121, order 1
2025-09-13 16:33:56,358 - jwst.assign_wcs.util - INFO - Excluding off-image object: 122, order 1
2025-09-13 16:33:56,370 - jwst.assign_wcs.util - INFO - Excluding off-image object: 123, order 1
2025-09-13 16:33:56,383 - jwst.assign_wcs.util - INFO - Excluding off-image object: 124, order 1
2025-09-13 16:33:56,396 - jwst.assign_wcs.util - INFO - Excluding off-image object: 125, order 1
2025-09-13 16:33:56,408 - jwst.assign_wcs.util - INFO - Excluding off-image object: 126, order 1
2025-09-13 16:33:56,421 - jwst.assign_wcs.util - INFO - Excluding off-image object: 127, order 1
2025-09-13 16:33:56,433 - jwst.assign_wcs.util - INFO - Excluding off-image object: 128, order 1
2025-09-13 16:33:56,446 - jwst.assign_wcs.util - INFO - Excluding off-image object: 129, order 1
2025-09-13 16:33:56,458 - jwst.assign_wcs.util - INFO - Excluding off-image object: 130, order 1
2025-09-13 16:33:56,471 - jwst.assign_wcs.util - INFO - Excluding off-image object: 131, order 1
2025-09-13 16:33:56,484 - jwst.assign_wcs.util - INFO - Excluding off-image object: 132, order 1
2025-09-13 16:33:56,497 - jwst.assign_wcs.util - INFO - Excluding off-image object: 133, order 1
2025-09-13 16:33:56,509 - jwst.assign_wcs.util - INFO - Excluding off-image object: 134, order 1
2025-09-13 16:33:56,521 - jwst.assign_wcs.util - INFO - Excluding off-image object: 135, order 1
2025-09-13 16:33:56,534 - jwst.assign_wcs.util - INFO - Excluding off-image object: 136, order 1
2025-09-13 16:33:56,546 - jwst.assign_wcs.util - INFO - Excluding off-image object: 137, order 1
2025-09-13 16:33:56,559 - jwst.assign_wcs.util - INFO - Excluding off-image object: 138, order 1
2025-09-13 16:33:56,571 - jwst.assign_wcs.util - INFO - Excluding off-image object: 139, order 1
2025-09-13 16:33:56,584 - jwst.assign_wcs.util - INFO - Excluding off-image object: 140, order 1
2025-09-13 16:33:56,597 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 141 order: 1
2025-09-13 16:33:56,609 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 142 order: 1
2025-09-13 16:33:56,622 - jwst.assign_wcs.util - INFO - Excluding off-image object: 143, order 1
2025-09-13 16:33:56,634 - jwst.assign_wcs.util - INFO - Excluding off-image object: 144, order 1
2025-09-13 16:33:56,646 - jwst.assign_wcs.util - INFO - Excluding off-image object: 145, order 1
2025-09-13 16:33:56,659 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 146 order: 1
2025-09-13 16:33:56,672 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 147 order: 1
2025-09-13 16:33:56,684 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 148 order: 1
2025-09-13 16:33:56,697 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 149 order: 1
2025-09-13 16:33:56,709 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 150 order: 1
2025-09-13 16:33:56,722 - jwst.assign_wcs.util - INFO - Excluding off-image object: 151, order 1
2025-09-13 16:33:56,734 - jwst.assign_wcs.util - INFO - Excluding off-image object: 152, order 1
2025-09-13 16:33:56,751 - jwst.assign_wcs.util - INFO - Excluding off-image object: 153, order 1
2025-09-13 16:33:56,764 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 154 order: 1
2025-09-13 16:33:56,776 - jwst.assign_wcs.util - INFO - Excluding off-image object: 155, order 1
2025-09-13 16:33:56,788 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 156 order: 1
2025-09-13 16:33:56,802 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 157 order: 1
2025-09-13 16:33:56,814 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 158 order: 1
2025-09-13 16:33:56,827 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 159 order: 1
2025-09-13 16:33:56,839 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 160 order: 1
2025-09-13 16:33:56,851 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 161 order: 1
2025-09-13 16:33:56,864 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 162 order: 1
2025-09-13 16:33:56,877 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 163 order: 1
2025-09-13 16:33:56,889 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 164 order: 1
2025-09-13 16:33:56,901 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 165 order: 1
2025-09-13 16:33:56,914 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 166 order: 1
2025-09-13 16:33:56,928 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 167 order: 1
2025-09-13 16:33:56,941 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 168 order: 1
2025-09-13 16:33:56,953 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 169 order: 1
2025-09-13 16:33:56,966 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 170 order: 1
2025-09-13 16:33:56,978 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 171 order: 1
2025-09-13 16:33:56,991 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 172 order: 1
2025-09-13 16:33:57,003 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 173 order: 1
2025-09-13 16:33:57,016 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 174 order: 1
2025-09-13 16:33:57,028 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 175 order: 1
2025-09-13 16:33:57,041 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 176 order: 1
2025-09-13 16:33:57,054 - jwst.assign_wcs.util - INFO - Excluding off-image object: 177, order 1
2025-09-13 16:33:57,066 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 178 order: 1
2025-09-13 16:33:57,079 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 179 order: 1
2025-09-13 16:33:57,092 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 180 order: 1
2025-09-13 16:33:57,105 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 181 order: 1
2025-09-13 16:33:57,118 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 182 order: 1
2025-09-13 16:33:57,130 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 183 order: 1
2025-09-13 16:33:57,143 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 184 order: 1
2025-09-13 16:33:57,156 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 185 order: 1
2025-09-13 16:33:57,169 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 186 order: 1
2025-09-13 16:33:57,182 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 187 order: 1
2025-09-13 16:33:57,195 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 188 order: 1
2025-09-13 16:33:57,207 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 189 order: 1
2025-09-13 16:33:57,220 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 190 order: 1
2025-09-13 16:33:57,233 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 191 order: 1
2025-09-13 16:33:57,246 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 192 order: 1
2025-09-13 16:33:57,258 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 193 order: 1
2025-09-13 16:33:57,271 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 194 order: 1
2025-09-13 16:33:57,283 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 195 order: 1
2025-09-13 16:33:57,296 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 196 order: 1
2025-09-13 16:33:57,309 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 197 order: 1
2025-09-13 16:33:57,321 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 198 order: 1
2025-09-13 16:33:57,334 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 199 order: 1
2025-09-13 16:33:57,347 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 200 order: 1
2025-09-13 16:33:57,359 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 201 order: 1
2025-09-13 16:33:57,371 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 202 order: 1
2025-09-13 16:33:57,384 - jwst.assign_wcs.util - INFO - Excluding off-image object: 203, order 1
2025-09-13 16:33:57,397 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 204 order: 1
2025-09-13 16:33:57,410 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 205 order: 1
2025-09-13 16:33:57,423 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 206 order: 1
2025-09-13 16:33:57,435 - jwst.assign_wcs.util - INFO - Excluding off-image object: 207, order 1
2025-09-13 16:33:57,447 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 208 order: 1
2025-09-13 16:33:57,460 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 209 order: 1
2025-09-13 16:33:57,473 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 210 order: 1
2025-09-13 16:33:57,486 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 211 order: 1
2025-09-13 16:33:57,498 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 212 order: 1
2025-09-13 16:33:57,511 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 213 order: 1
2025-09-13 16:33:57,523 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 214 order: 1
2025-09-13 16:33:57,536 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 215 order: 1
2025-09-13 16:33:57,549 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 216 order: 1
2025-09-13 16:33:57,562 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 217 order: 1
2025-09-13 16:33:57,575 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 218 order: 1
2025-09-13 16:33:57,587 - jwst.assign_wcs.util - INFO - Excluding off-image object: 219, order 1
2025-09-13 16:33:57,600 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 220 order: 1
2025-09-13 16:33:57,624 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 222 order: 1
2025-09-13 16:33:57,649 - jwst.assign_wcs.util - INFO - Excluding off-image object: 224, order 1
2025-09-13 16:33:57,708 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 229 order: 1
2025-09-13 16:33:57,933 - jwst.assign_wcs.util - INFO - Excluding off-image object: 248, order 1
2025-09-13 16:33:57,945 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 249 order: 1
2025-09-13 16:33:58,511 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 296 order: 1
2025-09-13 16:33:58,609 - jwst.assign_wcs.util - INFO - Excluding off-image object: 304, order 1
2025-09-13 16:33:58,622 - jwst.assign_wcs.util - INFO - Excluding off-image object: 305, order 1
2025-09-13 16:33:58,634 - jwst.assign_wcs.util - INFO - Excluding off-image object: 306, order 1
2025-09-13 16:33:58,849 - jwst.assign_wcs.util - INFO - Excluding off-image object: 324, order 1
2025-09-13 16:33:58,910 - jwst.assign_wcs.util - INFO - Excluding off-image object: 329, order 1
2025-09-13 16:33:59,259 - jwst.assign_wcs.util - INFO - Excluding off-image object: 358, order 1
2025-09-13 16:33:59,344 - jwst.assign_wcs.util - INFO - Excluding off-image object: 365, order 1
2025-09-13 16:33:59,405 - jwst.assign_wcs.util - INFO - Excluding off-image object: 370, order 1
2025-09-13 16:33:59,418 - jwst.assign_wcs.util - INFO - Excluding off-image object: 371, order 1
2025-09-13 16:34:00,302 - jwst.assign_wcs.util - INFO - Excluding off-image object: 445, order 1
2025-09-13 16:34:00,350 - jwst.assign_wcs.util - INFO - Excluding off-image object: 449, order 1
2025-09-13 16:34:00,588 - jwst.assign_wcs.util - INFO - Excluding off-image object: 469, order 1
2025-09-13 16:34:00,779 - jwst.assign_wcs.util - INFO - Excluding off-image object: 485, order 1
2025-09-13 16:34:00,946 - jwst.assign_wcs.util - INFO - Excluding off-image object: 499, order 1
2025-09-13 16:34:01,930 - jwst.assign_wcs.util - INFO - Excluding off-image object: 582, order 1
2025-09-13 16:34:02,155 - jwst.assign_wcs.util - INFO - Excluding off-image object: 601, order 1
2025-09-13 16:34:02,250 - jwst.assign_wcs.util - INFO - Excluding off-image object: 609, order 1
2025-09-13 16:34:02,263 - jwst.assign_wcs.util - INFO - Excluding off-image object: 610, order 1
2025-09-13 16:34:02,696 - jwst.assign_wcs.util - INFO - Excluding off-image object: 647, order 1
2025-09-13 16:34:02,849 - jwst.assign_wcs.util - INFO - Excluding off-image object: 660, order 1
2025-09-13 16:34:02,909 - jwst.assign_wcs.util - INFO - Excluding off-image object: 665, order 1
2025-09-13 16:34:03,003 - jwst.assign_wcs.util - INFO - Excluding off-image object: 673, order 1
2025-09-13 16:34:03,273 - jwst.assign_wcs.util - INFO - Excluding off-image object: 696, order 1
2025-09-13 16:34:03,309 - jwst.assign_wcs.util - INFO - Excluding off-image object: 699, order 1
2025-09-13 16:34:03,509 - jwst.assign_wcs.util - INFO - Excluding off-image object: 716, order 1
2025-09-13 16:34:03,604 - jwst.assign_wcs.util - INFO - Excluding off-image object: 724, order 1
2025-09-13 16:34:03,819 - jwst.assign_wcs.util - INFO - Excluding off-image object: 742, order 1
2025-09-13 16:34:03,831 - jwst.assign_wcs.util - INFO - Excluding off-image object: 743, order 1
2025-09-13 16:34:04,033 - jwst.assign_wcs.util - INFO - Excluding off-image object: 760, order 1
2025-09-13 16:34:04,859 - jwst.assign_wcs.util - INFO - Excluding off-image object: 830, order 1
2025-09-13 16:34:04,895 - jwst.assign_wcs.util - INFO - Excluding off-image object: 833, order 1
2025-09-13 16:34:05,025 - jwst.assign_wcs.util - INFO - Excluding off-image object: 844, order 1
2025-09-13 16:34:05,144 - jwst.assign_wcs.util - INFO - Excluding off-image object: 854, order 1
2025-09-13 16:34:05,429 - jwst.assign_wcs.util - INFO - Excluding off-image object: 878, order 1
2025-09-13 16:34:05,619 - jwst.assign_wcs.util - INFO - Excluding off-image object: 894, order 1
2025-09-13 16:34:05,715 - jwst.assign_wcs.util - INFO - Excluding off-image object: 902, order 1
2025-09-13 16:34:05,895 - jwst.assign_wcs.util - INFO - Excluding off-image object: 917, order 1
2025-09-13 16:34:05,932 - jwst.assign_wcs.util - INFO - Excluding off-image object: 920, order 1
2025-09-13 16:34:06,719 - jwst.assign_wcs.util - INFO - Excluding off-image object: 986, order 1
2025-09-13 16:34:06,815 - jwst.assign_wcs.util - INFO - Excluding off-image object: 994, order 1
2025-09-13 16:34:06,900 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1001, order 1
2025-09-13 16:34:07,068 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1015, order 1
2025-09-13 16:34:07,106 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1018, order 1
2025-09-13 16:34:07,131 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1020, order 1
2025-09-13 16:34:07,299 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1034, order 1
2025-09-13 16:34:07,477 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1049 order: 1
2025-09-13 16:34:07,996 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1093, order 1
2025-09-13 16:34:08,043 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1097, order 1
2025-09-13 16:34:08,114 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1103, order 1
2025-09-13 16:34:08,197 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1110, order 1
2025-09-13 16:34:08,716 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1154, order 1
2025-09-13 16:34:08,753 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1157, order 1
2025-09-13 16:34:08,894 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1169, order 1
2025-09-13 16:34:08,942 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1173, order 1
2025-09-13 16:34:09,014 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1179, order 1
2025-09-13 16:34:09,285 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1202, order 1
2025-09-13 16:34:09,321 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1205, order 1
2025-09-13 16:34:09,392 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1211, order 1
2025-09-13 16:34:09,532 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1223, order 1
2025-09-13 16:34:09,591 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1228, order 1
2025-09-13 16:34:09,650 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1233, order 1
2025-09-13 16:34:10,270 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1286, order 1
2025-09-13 16:34:10,973 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1320, order 1
2025-09-13 16:34:11,009 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1323, order 1
2025-09-13 16:34:11,667 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1379, order 1
2025-09-13 16:34:12,193 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1425, order 1
2025-09-13 16:34:12,385 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1441, order 1
2025-09-13 16:34:12,482 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1449, order 1
2025-09-13 16:34:12,617 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1460 order: 1
2025-09-13 16:34:12,809 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1476 order: 1
2025-09-13 16:34:12,846 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1479 order: 1
2025-09-13 16:34:12,947 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1487, order 1
2025-09-13 16:34:13,022 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1493 order: 1
2025-09-13 16:34:13,035 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1494 order: 1
2025-09-13 16:34:13,047 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1495 order: 1
2025-09-13 16:34:13,072 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1497 order: 1
2025-09-13 16:34:13,086 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1498 order: 1
2025-09-13 16:34:13,098 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1499 order: 1
2025-09-13 16:34:13,111 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1500 order: 1
2025-09-13 16:34:13,123 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1501 order: 1
2025-09-13 16:34:13,136 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1502 order: 1
2025-09-13 16:34:13,137 - jwst.assign_wcs.util - INFO - Total of 1281 grism objects defined
2025-09-13 16:34:13,177 - jwst.background.background_sub_wfss - INFO - Starting iterative outlier rejection for background subtraction.
2025-09-13 16:34:13,765 - jwst.background.background_sub_wfss - INFO - Stopped at maxiter (5).
2025-09-13 16:34:13,944 - jwst.background.background_sub_wfss - INFO - Average of scaled background image = 4.448e-01
2025-09-13 16:34:13,945 - jwst.background.background_sub_wfss - INFO - Scaling factor = 4.63838e-01
2025-09-13 16:34:13,951 - stpipe.Spec2Pipeline.bkg_subtract - INFO - Step bkg_subtract done
2025-09-13 16:34:14,203 - stpipe.Spec2Pipeline.flat_field - INFO - Step flat_field running with args (<ImageModel(2048, 2048) from jw02079004003_03101_00003_nis_rate.fits>,).
2025-09-13 16:34:14,410 - stpipe.Spec2Pipeline.flat_field - INFO - Using FLAT reference file: /home/runner/crds/references/jwst/niriss/jwst_niriss_flat_0271.fits
2025-09-13 16:34:14,410 - stpipe.Spec2Pipeline.flat_field - INFO - No reference found for type FFLAT
2025-09-13 16:34:14,411 - stpipe.Spec2Pipeline.flat_field - INFO - No reference found for type SFLAT
2025-09-13 16:34:14,411 - stpipe.Spec2Pipeline.flat_field - INFO - No reference found for type DFLAT
2025-09-13 16:34:14,634 - stpipe.Spec2Pipeline.flat_field - INFO - Step flat_field done
2025-09-13 16:34:14,870 - stpipe.Spec2Pipeline.extract_2d - INFO - Step extract_2d running with args (<ImageModel(2048, 2048) from jw02079004003_03101_00003_nis_rate.fits>,).
2025-09-13 16:34:14,881 - jwst.extract_2d.extract_2d - INFO - EXP_TYPE is NIS_WFSS
2025-09-13 16:34:14,892 - jwst.assign_wcs.util - INFO - Getting objects from jw02079-o004_niriss_clear-f200w_cat.ecsv
2025-09-13 16:34:15,191 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1, order 1
2025-09-13 16:34:15,203 - jwst.assign_wcs.util - INFO - Excluding off-image object: 2, order 1
2025-09-13 16:34:15,212 - jwst.assign_wcs.util - INFO - Excluding off-image object: 3, order 1
2025-09-13 16:34:15,224 - jwst.assign_wcs.util - INFO - Excluding off-image object: 4, order 1
2025-09-13 16:34:15,236 - jwst.assign_wcs.util - INFO - Excluding off-image object: 5, order 1
2025-09-13 16:34:15,248 - jwst.assign_wcs.util - INFO - Excluding off-image object: 6, order 1
2025-09-13 16:34:15,260 - jwst.assign_wcs.util - INFO - Excluding off-image object: 7, order 1
2025-09-13 16:34:15,272 - jwst.assign_wcs.util - INFO - Excluding off-image object: 8, order 1
2025-09-13 16:34:15,284 - jwst.assign_wcs.util - INFO - Excluding off-image object: 9, order 1
2025-09-13 16:34:15,296 - jwst.assign_wcs.util - INFO - Excluding off-image object: 10, order 1
2025-09-13 16:34:15,308 - jwst.assign_wcs.util - INFO - Excluding off-image object: 11, order 1
2025-09-13 16:34:15,320 - jwst.assign_wcs.util - INFO - Excluding off-image object: 12, order 1
2025-09-13 16:34:15,332 - jwst.assign_wcs.util - INFO - Excluding off-image object: 13, order 1
2025-09-13 16:34:15,344 - jwst.assign_wcs.util - INFO - Excluding off-image object: 14, order 1
2025-09-13 16:34:15,356 - jwst.assign_wcs.util - INFO - Excluding off-image object: 15, order 1
2025-09-13 16:34:15,368 - jwst.assign_wcs.util - INFO - Excluding off-image object: 16, order 1
2025-09-13 16:34:15,380 - jwst.assign_wcs.util - INFO - Excluding off-image object: 17, order 1
2025-09-13 16:34:15,392 - jwst.assign_wcs.util - INFO - Excluding off-image object: 18, order 1
2025-09-13 16:34:15,404 - jwst.assign_wcs.util - INFO - Excluding off-image object: 19, order 1
2025-09-13 16:34:15,416 - jwst.assign_wcs.util - INFO - Excluding off-image object: 20, order 1
2025-09-13 16:34:15,428 - jwst.assign_wcs.util - INFO - Excluding off-image object: 21, order 1
2025-09-13 16:34:15,439 - jwst.assign_wcs.util - INFO - Excluding off-image object: 22, order 1
2025-09-13 16:34:15,451 - jwst.assign_wcs.util - INFO - Excluding off-image object: 23, order 1
2025-09-13 16:34:15,463 - jwst.assign_wcs.util - INFO - Excluding off-image object: 24, order 1
2025-09-13 16:34:15,475 - jwst.assign_wcs.util - INFO - Excluding off-image object: 25, order 1
2025-09-13 16:34:15,484 - jwst.assign_wcs.util - INFO - Excluding off-image object: 26, order 1
2025-09-13 16:34:15,496 - jwst.assign_wcs.util - INFO - Excluding off-image object: 27, order 1
2025-09-13 16:34:15,508 - jwst.assign_wcs.util - INFO - Excluding off-image object: 28, order 1
2025-09-13 16:34:15,520 - jwst.assign_wcs.util - INFO - Excluding off-image object: 29, order 1
2025-09-13 16:34:15,532 - jwst.assign_wcs.util - INFO - Excluding off-image object: 30, order 1
2025-09-13 16:34:15,541 - jwst.assign_wcs.util - INFO - Excluding off-image object: 31, order 1
2025-09-13 16:34:15,553 - jwst.assign_wcs.util - INFO - Excluding off-image object: 32, order 1
2025-09-13 16:34:15,562 - jwst.assign_wcs.util - INFO - Excluding off-image object: 33, order 1
2025-09-13 16:34:15,574 - jwst.assign_wcs.util - INFO - Excluding off-image object: 34, order 1
2025-09-13 16:34:15,585 - jwst.assign_wcs.util - INFO - Excluding off-image object: 35, order 1
2025-09-13 16:34:15,594 - jwst.assign_wcs.util - INFO - Excluding off-image object: 36, order 1
2025-09-13 16:34:15,606 - jwst.assign_wcs.util - INFO - Excluding off-image object: 37, order 1
2025-09-13 16:34:15,615 - jwst.assign_wcs.util - INFO - Excluding off-image object: 38, order 1
2025-09-13 16:34:15,627 - jwst.assign_wcs.util - INFO - Excluding off-image object: 39, order 1
2025-09-13 16:34:15,639 - jwst.assign_wcs.util - INFO - Excluding off-image object: 40, order 1
2025-09-13 16:34:15,651 - jwst.assign_wcs.util - INFO - Excluding off-image object: 41, order 1
2025-09-13 16:34:15,660 - jwst.assign_wcs.util - INFO - Excluding off-image object: 42, order 1
2025-09-13 16:34:15,669 - jwst.assign_wcs.util - INFO - Excluding off-image object: 43, order 1
2025-09-13 16:34:15,681 - jwst.assign_wcs.util - INFO - Excluding off-image object: 44, order 1
2025-09-13 16:34:15,693 - jwst.assign_wcs.util - INFO - Excluding off-image object: 45, order 1
2025-09-13 16:34:15,702 - jwst.assign_wcs.util - INFO - Excluding off-image object: 46, order 1
2025-09-13 16:34:15,714 - jwst.assign_wcs.util - INFO - Excluding off-image object: 47, order 1
2025-09-13 16:34:15,723 - jwst.assign_wcs.util - INFO - Excluding off-image object: 48, order 1
2025-09-13 16:34:15,735 - jwst.assign_wcs.util - INFO - Excluding off-image object: 49, order 1
2025-09-13 16:34:15,744 - jwst.assign_wcs.util - INFO - Excluding off-image object: 50, order 1
2025-09-13 16:34:15,753 - jwst.assign_wcs.util - INFO - Excluding off-image object: 51, order 1
2025-09-13 16:34:15,762 - jwst.assign_wcs.util - INFO - Excluding off-image object: 52, order 1
2025-09-13 16:34:15,771 - jwst.assign_wcs.util - INFO - Excluding off-image object: 53, order 1
2025-09-13 16:34:15,783 - jwst.assign_wcs.util - INFO - Excluding off-image object: 54, order 1
2025-09-13 16:34:15,792 - jwst.assign_wcs.util - INFO - Excluding off-image object: 55, order 1
2025-09-13 16:34:15,801 - jwst.assign_wcs.util - INFO - Excluding off-image object: 56, order 1
2025-09-13 16:34:15,813 - jwst.assign_wcs.util - INFO - Excluding off-image object: 57, order 1
2025-09-13 16:34:15,825 - jwst.assign_wcs.util - INFO - Excluding off-image object: 58, order 1
2025-09-13 16:34:15,834 - jwst.assign_wcs.util - INFO - Excluding off-image object: 59, order 1
2025-09-13 16:34:15,843 - jwst.assign_wcs.util - INFO - Excluding off-image object: 60, order 1
2025-09-13 16:34:15,852 - jwst.assign_wcs.util - INFO - Excluding off-image object: 61, order 1
2025-09-13 16:34:15,861 - jwst.assign_wcs.util - INFO - Excluding off-image object: 62, order 1
2025-09-13 16:34:15,873 - jwst.assign_wcs.util - INFO - Excluding off-image object: 63, order 1
2025-09-13 16:34:15,884 - jwst.assign_wcs.util - INFO - Excluding off-image object: 64, order 1
2025-09-13 16:34:15,893 - jwst.assign_wcs.util - INFO - Excluding off-image object: 65, order 1
2025-09-13 16:34:15,906 - jwst.assign_wcs.util - INFO - Excluding off-image object: 66, order 1
2025-09-13 16:34:15,915 - jwst.assign_wcs.util - INFO - Excluding off-image object: 67, order 1
2025-09-13 16:34:15,924 - jwst.assign_wcs.util - INFO - Excluding off-image object: 68, order 1
2025-09-13 16:34:15,936 - jwst.assign_wcs.util - INFO - Excluding off-image object: 69, order 1
2025-09-13 16:34:15,948 - jwst.assign_wcs.util - INFO - Excluding off-image object: 70, order 1
2025-09-13 16:34:15,960 - jwst.assign_wcs.util - INFO - Excluding off-image object: 71, order 1
2025-09-13 16:34:15,969 - jwst.assign_wcs.util - INFO - Excluding off-image object: 72, order 1
2025-09-13 16:34:15,978 - jwst.assign_wcs.util - INFO - Excluding off-image object: 73, order 1
2025-09-13 16:34:15,993 - jwst.assign_wcs.util - INFO - Excluding off-image object: 74, order 1
2025-09-13 16:34:16,008 - jwst.assign_wcs.util - INFO - Excluding off-image object: 75, order 1
2025-09-13 16:34:16,018 - jwst.assign_wcs.util - INFO - Excluding off-image object: 76, order 1
2025-09-13 16:34:16,030 - jwst.assign_wcs.util - INFO - Excluding off-image object: 77, order 1
2025-09-13 16:34:16,042 - jwst.assign_wcs.util - INFO - Excluding off-image object: 78, order 1
2025-09-13 16:34:16,051 - jwst.assign_wcs.util - INFO - Excluding off-image object: 79, order 1
2025-09-13 16:34:16,063 - jwst.assign_wcs.util - INFO - Excluding off-image object: 80, order 1
2025-09-13 16:34:16,072 - jwst.assign_wcs.util - INFO - Excluding off-image object: 81, order 1
2025-09-13 16:34:16,081 - jwst.assign_wcs.util - INFO - Excluding off-image object: 82, order 1
2025-09-13 16:34:16,093 - jwst.assign_wcs.util - INFO - Excluding off-image object: 83, order 1
2025-09-13 16:34:16,103 - jwst.assign_wcs.util - INFO - Excluding off-image object: 84, order 1
2025-09-13 16:34:16,111 - jwst.assign_wcs.util - INFO - Excluding off-image object: 85, order 1
2025-09-13 16:34:16,121 - jwst.assign_wcs.util - INFO - Excluding off-image object: 86, order 1
2025-09-13 16:34:16,133 - jwst.assign_wcs.util - INFO - Excluding off-image object: 87, order 1
2025-09-13 16:34:16,142 - jwst.assign_wcs.util - INFO - Excluding off-image object: 88, order 1
2025-09-13 16:34:16,151 - jwst.assign_wcs.util - INFO - Excluding off-image object: 89, order 1
2025-09-13 16:34:16,163 - jwst.assign_wcs.util - INFO - Excluding off-image object: 90, order 1
2025-09-13 16:34:16,172 - jwst.assign_wcs.util - INFO - Excluding off-image object: 91, order 1
2025-09-13 16:34:16,184 - jwst.assign_wcs.util - INFO - Excluding off-image object: 92, order 1
2025-09-13 16:34:16,194 - jwst.assign_wcs.util - INFO - Excluding off-image object: 93, order 1
2025-09-13 16:34:16,203 - jwst.assign_wcs.util - INFO - Excluding off-image object: 94, order 1
2025-09-13 16:34:16,212 - jwst.assign_wcs.util - INFO - Excluding off-image object: 95, order 1
2025-09-13 16:34:16,224 - jwst.assign_wcs.util - INFO - Excluding off-image object: 96, order 1
2025-09-13 16:34:16,236 - jwst.assign_wcs.util - INFO - Excluding off-image object: 97, order 1
2025-09-13 16:34:16,245 - jwst.assign_wcs.util - INFO - Excluding off-image object: 98, order 1
2025-09-13 16:34:16,254 - jwst.assign_wcs.util - INFO - Excluding off-image object: 99, order 1
2025-09-13 16:34:16,263 - jwst.assign_wcs.util - INFO - Excluding off-image object: 100, order 1
2025-09-13 16:34:16,273 - jwst.assign_wcs.util - INFO - Excluding off-image object: 101, order 1
2025-09-13 16:34:16,282 - jwst.assign_wcs.util - INFO - Excluding off-image object: 102, order 1
2025-09-13 16:34:16,291 - jwst.assign_wcs.util - INFO - Excluding off-image object: 103, order 1
2025-09-13 16:34:16,301 - jwst.assign_wcs.util - INFO - Excluding off-image object: 104, order 1
2025-09-13 16:34:16,313 - jwst.assign_wcs.util - INFO - Excluding off-image object: 105, order 1
2025-09-13 16:34:16,322 - jwst.assign_wcs.util - INFO - Excluding off-image object: 106, order 1
2025-09-13 16:34:16,331 - jwst.assign_wcs.util - INFO - Excluding off-image object: 107, order 1
2025-09-13 16:34:16,343 - jwst.assign_wcs.util - INFO - Excluding off-image object: 108, order 1
2025-09-13 16:34:16,352 - jwst.assign_wcs.util - INFO - Excluding off-image object: 109, order 1
2025-09-13 16:34:16,364 - jwst.assign_wcs.util - INFO - Excluding off-image object: 110, order 1
2025-09-13 16:34:16,373 - jwst.assign_wcs.util - INFO - Excluding off-image object: 111, order 1
2025-09-13 16:34:16,382 - jwst.assign_wcs.util - INFO - Excluding off-image object: 112, order 1
2025-09-13 16:34:16,391 - jwst.assign_wcs.util - INFO - Excluding off-image object: 113, order 1
2025-09-13 16:34:16,400 - jwst.assign_wcs.util - INFO - Excluding off-image object: 114, order 1
2025-09-13 16:34:16,409 - jwst.assign_wcs.util - INFO - Excluding off-image object: 115, order 1
2025-09-13 16:34:16,428 - jwst.assign_wcs.util - INFO - Excluding off-image object: 116, order 1
2025-09-13 16:34:16,437 - jwst.assign_wcs.util - INFO - Excluding off-image object: 117, order 1
2025-09-13 16:34:16,446 - jwst.assign_wcs.util - INFO - Excluding off-image object: 118, order 1
2025-09-13 16:34:16,456 - jwst.assign_wcs.util - INFO - Excluding off-image object: 119, order 1
2025-09-13 16:34:16,467 - jwst.assign_wcs.util - INFO - Excluding off-image object: 120, order 1
2025-09-13 16:34:16,476 - jwst.assign_wcs.util - INFO - Excluding off-image object: 121, order 1
2025-09-13 16:34:16,488 - jwst.assign_wcs.util - INFO - Excluding off-image object: 122, order 1
2025-09-13 16:34:16,497 - jwst.assign_wcs.util - INFO - Excluding off-image object: 123, order 1
2025-09-13 16:34:16,506 - jwst.assign_wcs.util - INFO - Excluding off-image object: 124, order 1
2025-09-13 16:34:16,515 - jwst.assign_wcs.util - INFO - Excluding off-image object: 125, order 1
2025-09-13 16:34:16,524 - jwst.assign_wcs.util - INFO - Excluding off-image object: 126, order 1
2025-09-13 16:34:16,533 - jwst.assign_wcs.util - INFO - Excluding off-image object: 127, order 1
2025-09-13 16:34:16,542 - jwst.assign_wcs.util - INFO - Excluding off-image object: 128, order 1
2025-09-13 16:34:16,553 - jwst.assign_wcs.util - INFO - Excluding off-image object: 129, order 1
2025-09-13 16:34:16,562 - jwst.assign_wcs.util - INFO - Excluding off-image object: 130, order 1
2025-09-13 16:34:16,571 - jwst.assign_wcs.util - INFO - Excluding off-image object: 131, order 1
2025-09-13 16:34:16,580 - jwst.assign_wcs.util - INFO - Excluding off-image object: 132, order 1
2025-09-13 16:34:16,589 - jwst.assign_wcs.util - INFO - Excluding off-image object: 133, order 1
2025-09-13 16:34:16,598 - jwst.assign_wcs.util - INFO - Excluding off-image object: 134, order 1
2025-09-13 16:34:16,608 - jwst.assign_wcs.util - INFO - Excluding off-image object: 135, order 1
2025-09-13 16:34:16,620 - jwst.assign_wcs.util - INFO - Excluding off-image object: 136, order 1
2025-09-13 16:34:16,632 - jwst.assign_wcs.util - INFO - Excluding off-image object: 137, order 1
2025-09-13 16:34:16,644 - jwst.assign_wcs.util - INFO - Excluding off-image object: 138, order 1
2025-09-13 16:34:16,655 - jwst.assign_wcs.util - INFO - Excluding off-image object: 139, order 1
2025-09-13 16:34:16,665 - jwst.assign_wcs.util - INFO - Excluding off-image object: 140, order 1
2025-09-13 16:34:16,674 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 141 order: 1
2025-09-13 16:34:16,686 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 142 order: 1
2025-09-13 16:34:16,695 - jwst.assign_wcs.util - INFO - Excluding off-image object: 143, order 1
2025-09-13 16:34:16,706 - jwst.assign_wcs.util - INFO - Excluding off-image object: 144, order 1
2025-09-13 16:34:16,718 - jwst.assign_wcs.util - INFO - Excluding off-image object: 145, order 1
2025-09-13 16:34:16,727 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 146 order: 1
2025-09-13 16:34:16,739 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 147 order: 1
2025-09-13 16:34:16,748 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 148 order: 1
2025-09-13 16:34:16,757 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 149 order: 1
2025-09-13 16:34:16,766 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 150 order: 1
2025-09-13 16:34:16,775 - jwst.assign_wcs.util - INFO - Excluding off-image object: 151, order 1
2025-09-13 16:34:16,787 - jwst.assign_wcs.util - INFO - Excluding off-image object: 152, order 1
2025-09-13 16:34:16,798 - jwst.assign_wcs.util - INFO - Excluding off-image object: 153, order 1
2025-09-13 16:34:16,808 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 154 order: 1
2025-09-13 16:34:16,820 - jwst.assign_wcs.util - INFO - Excluding off-image object: 155, order 1
2025-09-13 16:34:16,829 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 156 order: 1
2025-09-13 16:34:16,838 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 157 order: 1
2025-09-13 16:34:16,847 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 158 order: 1
2025-09-13 16:34:16,856 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 159 order: 1
2025-09-13 16:34:16,865 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 160 order: 1
2025-09-13 16:34:16,874 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 161 order: 1
2025-09-13 16:34:16,886 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 162 order: 1
2025-09-13 16:34:16,895 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 163 order: 1
2025-09-13 16:34:16,907 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 164 order: 1
2025-09-13 16:34:16,919 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 165 order: 1
2025-09-13 16:34:16,928 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 166 order: 1
2025-09-13 16:34:16,940 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 167 order: 1
2025-09-13 16:34:16,949 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 168 order: 1
2025-09-13 16:34:16,957 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 169 order: 1
2025-09-13 16:34:16,966 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 170 order: 1
2025-09-13 16:34:16,976 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 171 order: 1
2025-09-13 16:34:16,985 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 172 order: 1
2025-09-13 16:34:16,997 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 173 order: 1
2025-09-13 16:34:17,006 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 174 order: 1
2025-09-13 16:34:17,015 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 175 order: 1
2025-09-13 16:34:17,027 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 176 order: 1
2025-09-13 16:34:17,036 - jwst.assign_wcs.util - INFO - Excluding off-image object: 177, order 1
2025-09-13 16:34:17,045 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 178 order: 1
2025-09-13 16:34:17,054 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 179 order: 1
2025-09-13 16:34:17,063 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 180 order: 1
2025-09-13 16:34:17,074 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 181 order: 1
2025-09-13 16:34:17,086 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 182 order: 1
2025-09-13 16:34:17,096 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 183 order: 1
2025-09-13 16:34:17,108 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 184 order: 1
2025-09-13 16:34:17,117 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 185 order: 1
2025-09-13 16:34:17,126 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 186 order: 1
2025-09-13 16:34:17,134 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 187 order: 1
2025-09-13 16:34:17,146 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 188 order: 1
2025-09-13 16:34:17,155 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 189 order: 1
2025-09-13 16:34:17,167 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 190 order: 1
2025-09-13 16:34:17,176 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 191 order: 1
2025-09-13 16:34:17,185 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 192 order: 1
2025-09-13 16:34:17,194 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 193 order: 1
2025-09-13 16:34:17,203 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 194 order: 1
2025-09-13 16:34:17,212 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 195 order: 1
2025-09-13 16:34:17,221 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 196 order: 1
2025-09-13 16:34:17,230 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 197 order: 1
2025-09-13 16:34:17,238 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 198 order: 1
2025-09-13 16:34:17,250 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 199 order: 1
2025-09-13 16:34:17,259 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 200 order: 1
2025-09-13 16:34:17,268 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 201 order: 1
2025-09-13 16:34:17,277 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 202 order: 1
2025-09-13 16:34:17,286 - jwst.assign_wcs.util - INFO - Excluding off-image object: 203, order 1
2025-09-13 16:34:17,294 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 204 order: 1
2025-09-13 16:34:17,304 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 205 order: 1
2025-09-13 16:34:17,312 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 206 order: 1
2025-09-13 16:34:17,321 - jwst.assign_wcs.util - INFO - Excluding off-image object: 207, order 1
2025-09-13 16:34:17,330 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 208 order: 1
2025-09-13 16:34:17,339 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 209 order: 1
2025-09-13 16:34:17,351 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 210 order: 1
2025-09-13 16:34:17,363 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 211 order: 1
2025-09-13 16:34:17,371 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 212 order: 1
2025-09-13 16:34:17,380 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 213 order: 1
2025-09-13 16:34:17,389 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 214 order: 1
2025-09-13 16:34:17,398 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 215 order: 1
2025-09-13 16:34:17,407 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 216 order: 1
2025-09-13 16:34:17,416 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 217 order: 1
2025-09-13 16:34:17,425 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 218 order: 1
2025-09-13 16:34:17,436 - jwst.assign_wcs.util - INFO - Excluding off-image object: 219, order 1
2025-09-13 16:34:17,448 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 220 order: 1
2025-09-13 16:34:17,471 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 222 order: 1
2025-09-13 16:34:17,490 - jwst.assign_wcs.util - INFO - Excluding off-image object: 224, order 1
2025-09-13 16:34:17,537 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 229 order: 1
2025-09-13 16:34:17,709 - jwst.assign_wcs.util - INFO - Excluding off-image object: 248, order 1
2025-09-13 16:34:17,718 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 249 order: 1
2025-09-13 16:34:18,148 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 296 order: 1
2025-09-13 16:34:18,222 - jwst.assign_wcs.util - INFO - Excluding off-image object: 304, order 1
2025-09-13 16:34:18,235 - jwst.assign_wcs.util - INFO - Excluding off-image object: 305, order 1
2025-09-13 16:34:18,246 - jwst.assign_wcs.util - INFO - Excluding off-image object: 306, order 1
2025-09-13 16:34:18,406 - jwst.assign_wcs.util - INFO - Excluding off-image object: 324, order 1
2025-09-13 16:34:18,455 - jwst.assign_wcs.util - INFO - Excluding off-image object: 329, order 1
2025-09-13 16:34:18,727 - jwst.assign_wcs.util - INFO - Excluding off-image object: 358, order 1
2025-09-13 16:34:18,790 - jwst.assign_wcs.util - INFO - Excluding off-image object: 365, order 1
2025-09-13 16:34:18,841 - jwst.assign_wcs.util - INFO - Excluding off-image object: 370, order 1
2025-09-13 16:34:18,853 - jwst.assign_wcs.util - INFO - Excluding off-image object: 371, order 1
2025-09-13 16:34:19,550 - jwst.assign_wcs.util - INFO - Excluding off-image object: 445, order 1
2025-09-13 16:34:19,585 - jwst.assign_wcs.util - INFO - Excluding off-image object: 449, order 1
2025-09-13 16:34:19,774 - jwst.assign_wcs.util - INFO - Excluding off-image object: 469, order 1
2025-09-13 16:34:19,919 - jwst.assign_wcs.util - INFO - Excluding off-image object: 485, order 1
2025-09-13 16:34:20,047 - jwst.assign_wcs.util - INFO - Excluding off-image object: 499, order 1
2025-09-13 16:34:20,816 - jwst.assign_wcs.util - INFO - Excluding off-image object: 582, order 1
2025-09-13 16:34:21,001 - jwst.assign_wcs.util - INFO - Excluding off-image object: 601, order 1
2025-09-13 16:34:21,078 - jwst.assign_wcs.util - INFO - Excluding off-image object: 609, order 1
2025-09-13 16:34:21,090 - jwst.assign_wcs.util - INFO - Excluding off-image object: 610, order 1
2025-09-13 16:34:21,434 - jwst.assign_wcs.util - INFO - Excluding off-image object: 647, order 1
2025-09-13 16:34:21,558 - jwst.assign_wcs.util - INFO - Excluding off-image object: 660, order 1
2025-09-13 16:34:21,607 - jwst.assign_wcs.util - INFO - Excluding off-image object: 665, order 1
2025-09-13 16:34:21,683 - jwst.assign_wcs.util - INFO - Excluding off-image object: 673, order 1
2025-09-13 16:34:21,884 - jwst.assign_wcs.util - INFO - Excluding off-image object: 696, order 1
2025-09-13 16:34:21,913 - jwst.assign_wcs.util - INFO - Excluding off-image object: 699, order 1
2025-09-13 16:34:22,068 - jwst.assign_wcs.util - INFO - Excluding off-image object: 716, order 1
2025-09-13 16:34:22,138 - jwst.assign_wcs.util - INFO - Excluding off-image object: 724, order 1
2025-09-13 16:34:22,295 - jwst.assign_wcs.util - INFO - Excluding off-image object: 742, order 1
2025-09-13 16:34:22,304 - jwst.assign_wcs.util - INFO - Excluding off-image object: 743, order 1
2025-09-13 16:34:22,455 - jwst.assign_wcs.util - INFO - Excluding off-image object: 760, order 1
2025-09-13 16:34:23,092 - jwst.assign_wcs.util - INFO - Excluding off-image object: 830, order 1
2025-09-13 16:34:23,121 - jwst.assign_wcs.util - INFO - Excluding off-image object: 833, order 1
2025-09-13 16:34:23,218 - jwst.assign_wcs.util - INFO - Excluding off-image object: 844, order 1
2025-09-13 16:34:23,309 - jwst.assign_wcs.util - INFO - Excluding off-image object: 854, order 1
2025-09-13 16:34:23,535 - jwst.assign_wcs.util - INFO - Excluding off-image object: 878, order 1
2025-09-13 16:34:23,684 - jwst.assign_wcs.util - INFO - Excluding off-image object: 894, order 1
2025-09-13 16:34:23,757 - jwst.assign_wcs.util - INFO - Excluding off-image object: 902, order 1
2025-09-13 16:34:23,890 - jwst.assign_wcs.util - INFO - Excluding off-image object: 917, order 1
2025-09-13 16:34:23,916 - jwst.assign_wcs.util - INFO - Excluding off-image object: 920, order 1
2025-09-13 16:34:24,503 - jwst.assign_wcs.util - INFO - Excluding off-image object: 986, order 1
2025-09-13 16:34:24,575 - jwst.assign_wcs.util - INFO - Excluding off-image object: 994, order 1
2025-09-13 16:34:24,637 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1001, order 1
2025-09-13 16:34:24,764 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1015, order 1
2025-09-13 16:34:24,795 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1018, order 1
2025-09-13 16:34:24,812 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1020, order 1
2025-09-13 16:34:24,944 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1034, order 1
2025-09-13 16:34:25,083 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1049 order: 1
2025-09-13 16:34:25,490 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1093, order 1
2025-09-13 16:34:25,530 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1097, order 1
2025-09-13 16:34:25,584 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1103, order 1
2025-09-13 16:34:25,655 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1110, order 1
2025-09-13 16:34:26,049 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1154, order 1
2025-09-13 16:34:26,081 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1157, order 1
2025-09-13 16:34:26,188 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1169, order 1
2025-09-13 16:34:26,222 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1173, order 1
2025-09-13 16:34:26,277 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1179, order 1
2025-09-13 16:34:26,481 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1202, order 1
2025-09-13 16:34:26,511 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1205, order 1
2025-09-13 16:34:26,567 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1211, order 1
2025-09-13 16:34:26,682 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1223, order 1
2025-09-13 16:34:26,727 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1228, order 1
2025-09-13 16:34:26,773 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1233, order 1
2025-09-13 16:34:27,264 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1286, order 1
2025-09-13 16:34:27,584 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1320, order 1
2025-09-13 16:34:27,616 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1323, order 1
2025-09-13 16:34:28,141 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1379, order 1
2025-09-13 16:34:28,565 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1425, order 1
2025-09-13 16:34:28,717 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1441, order 1
2025-09-13 16:34:28,788 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1449, order 1
2025-09-13 16:34:28,887 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1460 order: 1
2025-09-13 16:34:29,044 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1476 order: 1
2025-09-13 16:34:29,072 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1479 order: 1
2025-09-13 16:34:29,143 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1487, order 1
2025-09-13 16:34:29,199 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1493 order: 1
2025-09-13 16:34:29,208 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1494 order: 1
2025-09-13 16:34:29,217 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1495 order: 1
2025-09-13 16:34:29,235 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1497 order: 1
2025-09-13 16:34:29,244 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1498 order: 1
2025-09-13 16:34:29,253 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1499 order: 1
2025-09-13 16:34:29,265 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1500 order: 1
2025-09-13 16:34:29,277 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1501 order: 1
2025-09-13 16:34:29,288 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1502 order: 1
2025-09-13 16:34:29,293 - jwst.assign_wcs.util - INFO - Total of 100 grism objects defined
2025-09-13 16:34:29,317 - jwst.extract_2d.grisms - INFO - Grism object list created from source catalog: jw02079-o004_niriss_clear-f200w_cat.ecsv
2025-09-13 16:34:29,318 - jwst.extract_2d.grisms - INFO - Extracting 100 grism objects
2025-09-13 16:34:29,680 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 522 order: 1:
2025-09-13 16:34:29,680 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:613, xmax:760), (ymin:415, ymax:685)
2025-09-13 16:34:29,865 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 796 order: 1:
2025-09-13 16:34:29,866 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1792, xmax:1886), (ymin:839, ymax:1056)
2025-09-13 16:34:30,041 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 1479 order: 1:
2025-09-13 16:34:30,042 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:143, xmax:244), (ymin:1873, ymax:2048)
2025-09-13 16:34:30,215 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 214 order: 1:
2025-09-13 16:34:30,215 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:307, xmax:391), (ymin:0, ymax:216)
2025-09-13 16:34:30,388 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 693 order: 1:
2025-09-13 16:34:30,389 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:90, xmax:160), (ymin:671, ymax:868)
2025-09-13 16:34:30,561 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 1120 order: 1:
2025-09-13 16:34:30,562 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:509, xmax:617), (ymin:1297, ymax:1488)
2025-09-13 16:34:30,734 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 1257 order: 1:
2025-09-13 16:34:30,735 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1448, xmax:1550), (ymin:1490, ymax:1690)
2025-09-13 16:34:30,906 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 766 order: 1:
2025-09-13 16:34:30,906 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:950, xmax:1001), (ymin:796, ymax:1022)
2025-09-13 16:34:31,082 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 606 order: 1:
2025-09-13 16:34:31,083 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:438, xmax:448), (ymin:531, ymax:717)
2025-09-13 16:34:31,251 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 649 order: 1:
2025-09-13 16:34:31,252 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1534, xmax:1623), (ymin:599, ymax:816)
2025-09-13 16:34:31,429 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 982 order: 1:
2025-09-13 16:34:31,429 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:398, xmax:446), (ymin:1094, ymax:1273)
2025-09-13 16:34:31,600 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 1364 order: 1:
2025-09-13 16:34:31,601 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1359, xmax:1402), (ymin:1664, ymax:1848)
2025-09-13 16:34:31,771 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 898 order: 1:
2025-09-13 16:34:31,772 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1414, xmax:1424), (ymin:981, ymax:1196)
2025-09-13 16:34:31,941 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 1049 order: 1:
2025-09-13 16:34:31,942 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:0, xmax:7), (ymin:1193, ymax:1391)
2025-09-13 16:34:32,111 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 732 order: 1:
2025-09-13 16:34:32,112 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:495, xmax:559), (ymin:739, ymax:906)
2025-09-13 16:34:32,280 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 189 order: 1:
2025-09-13 16:34:32,281 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1112, xmax:1159), (ymin:0, ymax:123)
2025-09-13 16:34:32,453 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 881 order: 1:
2025-09-13 16:34:32,454 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1147, xmax:1157), (ymin:951, ymax:1136)
2025-09-13 16:34:32,937 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 966 order: 1:
2025-09-13 16:34:32,938 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1382, xmax:1436), (ymin:1085, ymax:1268)
2025-09-13 16:34:33,108 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 914 order: 1:
2025-09-13 16:34:33,109 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1761, xmax:1804), (ymin:1005, ymax:1160)
2025-09-13 16:34:33,280 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 1084 order: 1:
2025-09-13 16:34:33,281 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1806, xmax:1816), (ymin:1257, ymax:1422)
2025-09-13 16:34:33,451 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 540 order: 1:
2025-09-13 16:34:33,452 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1677, xmax:1739), (ymin:441, ymax:635)
2025-09-13 16:34:33,624 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 1476 order: 1:
2025-09-13 16:34:33,625 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:0, xmax:32), (ymin:1871, ymax:2048)
2025-09-13 16:34:33,794 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 1142 order: 1:
2025-09-13 16:34:33,795 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:70, xmax:113), (ymin:1327, ymax:1497)
2025-09-13 16:34:33,975 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 220 order: 1:
2025-09-13 16:34:33,976 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:141, xmax:151), (ymin:0, ymax:172)
2025-09-13 16:34:34,151 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 289 order: 1:
2025-09-13 16:34:34,151 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1853, xmax:1901), (ymin:99, ymax:256)
2025-09-13 16:34:34,327 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 934 order: 1:
2025-09-13 16:34:34,328 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:676, xmax:726), (ymin:1031, ymax:1202)
2025-09-13 16:34:34,502 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 1219 order: 1:
2025-09-13 16:34:34,503 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:913, xmax:958), (ymin:1442, ymax:1626)
2025-09-13 16:34:34,680 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 927 order: 1:
2025-09-13 16:34:34,680 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:774, xmax:826), (ymin:1018, ymax:1185)
2025-09-13 16:34:34,861 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 1417 order: 1:
2025-09-13 16:34:34,861 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:126, xmax:164), (ymin:1760, ymax:1922)
2025-09-13 16:34:35,037 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 567 order: 1:
2025-09-13 16:34:35,038 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1641, xmax:1686), (ymin:489, ymax:660)
2025-09-13 16:34:35,211 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 1296 order: 1:
2025-09-13 16:34:35,211 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:619, xmax:660), (ymin:1545, ymax:1712)
2025-09-13 16:34:35,384 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 1412 order: 1:
2025-09-13 16:34:35,385 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:840, xmax:879), (ymin:1755, ymax:1918)
2025-09-13 16:34:35,561 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 654 order: 1:
2025-09-13 16:34:35,561 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1747, xmax:1812), (ymin:608, ymax:789)
2025-09-13 16:34:35,739 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 1029 order: 1:
2025-09-13 16:34:35,739 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:96, xmax:169), (ymin:1158, ymax:1338)
2025-09-13 16:34:35,914 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 553 order: 1:
2025-09-13 16:34:35,914 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:415, xmax:462), (ymin:458, ymax:615)
2025-09-13 16:34:36,089 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 1387 order: 1:
2025-09-13 16:34:36,089 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1969, xmax:2007), (ymin:1710, ymax:1874)
2025-09-13 16:34:36,263 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 422 order: 1:
2025-09-13 16:34:36,264 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1524, xmax:1555), (ymin:266, ymax:416)
2025-09-13 16:34:36,437 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 821 order: 1:
2025-09-13 16:34:36,438 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:90, xmax:126), (ymin:858, ymax:1024)
2025-09-13 16:34:36,608 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 682 order: 1:
2025-09-13 16:34:36,608 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:943, xmax:984), (ymin:663, ymax:836)
2025-09-13 16:34:37,118 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 1140 order: 1:
2025-09-13 16:34:37,119 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1605, xmax:1653), (ymin:1333, ymax:1498)
2025-09-13 16:34:37,292 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 1388 order: 1:
2025-09-13 16:34:37,293 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1741, xmax:1792), (ymin:1711, ymax:1893)
2025-09-13 16:34:37,470 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 759 order: 1:
2025-09-13 16:34:37,471 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1139, xmax:1184), (ymin:788, ymax:951)
2025-09-13 16:34:37,646 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 1407 order: 1:
2025-09-13 16:34:37,646 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1237, xmax:1278), (ymin:1739, ymax:1898)
2025-09-13 16:34:37,821 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 1194 order: 1:
2025-09-13 16:34:37,821 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1661, xmax:1702), (ymin:1395, ymax:1547)
2025-09-13 16:34:37,995 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 712 order: 1:
2025-09-13 16:34:37,996 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1277, xmax:1317), (ymin:708, ymax:865)
2025-09-13 16:34:38,167 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 539 order: 1:
2025-09-13 16:34:38,167 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1587, xmax:1614), (ymin:441, ymax:606)
2025-09-13 16:34:38,338 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 1008 order: 1:
2025-09-13 16:34:38,339 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1000, xmax:1031), (ymin:1136, ymax:1291)
2025-09-13 16:34:38,508 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 347 order: 1:
2025-09-13 16:34:38,508 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:688, xmax:698), (ymin:163, ymax:321)
2025-09-13 16:34:38,676 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 276 order: 1:
2025-09-13 16:34:38,677 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1270, xmax:1313), (ymin:76, ymax:242)
2025-09-13 16:34:38,850 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 605 order: 1:
2025-09-13 16:34:38,851 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:315, xmax:325), (ymin:531, ymax:676)
2025-09-13 16:34:39,024 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 922 order: 1:
2025-09-13 16:34:39,024 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1688, xmax:1718), (ymin:1014, ymax:1167)
2025-09-13 16:34:39,196 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 736 order: 1:
2025-09-13 16:34:39,197 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:2011, xmax:2034), (ymin:753, ymax:898)
2025-09-13 16:34:39,370 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 1423 order: 1:
2025-09-13 16:34:39,371 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:182, xmax:214), (ymin:1780, ymax:1937)
2025-09-13 16:34:39,545 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 800 order: 1:
2025-09-13 16:34:39,546 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:765, xmax:793), (ymin:838, ymax:988)
2025-09-13 16:34:39,718 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 873 order: 1:
2025-09-13 16:34:39,719 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1978, xmax:2000), (ymin:946, ymax:1095)
2025-09-13 16:34:39,893 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 385 order: 1:
2025-09-13 16:34:39,894 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:402, xmax:443), (ymin:208, ymax:351)
2025-09-13 16:34:40,071 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 557 order: 1:
2025-09-13 16:34:40,071 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:300, xmax:338), (ymin:470, ymax:631)
2025-09-13 16:34:40,247 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 719 order: 1:
2025-09-13 16:34:40,247 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1562, xmax:1586), (ymin:719, ymax:871)
2025-09-13 16:34:40,421 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 389 order: 1:
2025-09-13 16:34:40,422 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:458, xmax:490), (ymin:212, ymax:365)
2025-09-13 16:34:40,595 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 733 order: 1:
2025-09-13 16:34:40,595 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1830, xmax:1883), (ymin:748, ymax:914)
2025-09-13 16:34:40,765 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 1442 order: 1:
2025-09-13 16:34:40,765 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:656, xmax:699), (ymin:1815, ymax:1983)
2025-09-13 16:34:40,934 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 417 order: 1:
2025-09-13 16:34:40,935 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:911, xmax:936), (ymin:253, ymax:405)
2025-09-13 16:34:41,489 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 630 order: 1:
2025-09-13 16:34:41,489 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1880, xmax:1890), (ymin:565, ymax:703)
2025-09-13 16:34:41,667 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 925 order: 1:
2025-09-13 16:34:41,667 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:395, xmax:437), (ymin:1011, ymax:1167)
2025-09-13 16:34:41,847 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 527 order: 1:
2025-09-13 16:34:41,847 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1868, xmax:1896), (ymin:427, ymax:585)
2025-09-13 16:34:42,028 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 439 order: 1:
2025-09-13 16:34:42,028 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:784, xmax:794), (ymin:285, ymax:440)
2025-09-13 16:34:42,204 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 1253 order: 1:
2025-09-13 16:34:42,205 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:225, xmax:249), (ymin:1481, ymax:1638)
2025-09-13 16:34:42,384 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 1162 order: 1:
2025-09-13 16:34:42,385 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:905, xmax:926), (ymin:1352, ymax:1495)
2025-09-13 16:34:42,564 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 1457 order: 1:
2025-09-13 16:34:42,564 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:261, xmax:284), (ymin:1841, ymax:1990)
2025-09-13 16:34:42,739 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 694 order: 1:
2025-09-13 16:34:42,740 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:343, xmax:387), (ymin:672, ymax:817)
2025-09-13 16:34:42,915 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 1266 order: 1:
2025-09-13 16:34:42,916 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:808, xmax:845), (ymin:1503, ymax:1654)
2025-09-13 16:34:43,089 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 298 order: 1:
2025-09-13 16:34:43,090 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1140, xmax:1172), (ymin:105, ymax:250)
2025-09-13 16:34:43,264 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 516 order: 1:
2025-09-13 16:34:43,265 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:572, xmax:602), (ymin:407, ymax:563)
2025-09-13 16:34:43,440 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 973 order: 1:
2025-09-13 16:34:43,441 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:549, xmax:571), (ymin:1087, ymax:1232)
2025-09-13 16:34:43,607 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 180 order: 1:
2025-09-13 16:34:43,608 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1469, xmax:1511), (ymin:0, ymax:97)
2025-09-13 16:34:43,781 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 980 order: 1:
2025-09-13 16:34:43,782 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1454, xmax:1494), (ymin:1099, ymax:1252)
2025-09-13 16:34:43,957 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 263 order: 1:
2025-09-13 16:34:43,958 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:925, xmax:963), (ymin:47, ymax:195)
2025-09-13 16:34:44,128 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 493 order: 1:
2025-09-13 16:34:44,129 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1506, xmax:1536), (ymin:372, ymax:525)
2025-09-13 16:34:44,299 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 981 order: 1:
2025-09-13 16:34:44,300 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1824, xmax:1844), (ymin:1100, ymax:1246)
2025-09-13 16:34:44,473 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 1371 order: 1:
2025-09-13 16:34:44,474 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:724, xmax:747), (ymin:1672, ymax:1819)
2025-09-13 16:34:44,648 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 536 order: 1:
2025-09-13 16:34:44,648 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:475, xmax:498), (ymin:431, ymax:588)
2025-09-13 16:34:44,821 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 749 order: 1:
2025-09-13 16:34:44,822 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1582, xmax:1607), (ymin:775, ymax:920)
2025-09-13 16:34:44,995 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 345 order: 1:
2025-09-13 16:34:44,996 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:948, xmax:969), (ymin:162, ymax:306)
2025-09-13 16:34:45,164 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 721 order: 1:
2025-09-13 16:34:45,165 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:221, xmax:231), (ymin:714, ymax:855)
2025-09-13 16:34:45,334 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 387 order: 1:
2025-09-13 16:34:45,334 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1481, xmax:1505), (ymin:215, ymax:356)
2025-09-13 16:34:45,503 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 505 order: 1:
2025-09-13 16:34:45,504 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1536, xmax:1558), (ymin:402, ymax:546)
2025-09-13 16:34:45,674 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 566 order: 1:
2025-09-13 16:34:45,675 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1212, xmax:1235), (ymin:487, ymax:646)
2025-09-13 16:34:45,844 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 772 order: 1:
2025-09-13 16:34:45,844 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1713, xmax:1739), (ymin:804, ymax:952)
2025-09-13 16:34:46,430 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 722 order: 1:
2025-09-13 16:34:46,431 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:489, xmax:520), (ymin:717, ymax:866)
2025-09-13 16:34:46,605 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 872 order: 1:
2025-09-13 16:34:46,605 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1524, xmax:1534), (ymin:944, ymax:1086)
2025-09-13 16:34:46,783 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 933 order: 1:
2025-09-13 16:34:46,784 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:126, xmax:162), (ymin:1028, ymax:1177)
2025-09-13 16:34:46,960 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 1128 order: 1:
2025-09-13 16:34:46,960 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1789, xmax:1799), (ymin:1316, ymax:1454)
2025-09-13 16:34:47,138 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 1282 order: 1:
2025-09-13 16:34:47,139 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:897, xmax:931), (ymin:1533, ymax:1692)
2025-09-13 16:34:47,314 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 274 order: 1:
2025-09-13 16:34:47,315 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:488, xmax:519), (ymin:64, ymax:218)
2025-09-13 16:34:47,486 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 641 order: 1:
2025-09-13 16:34:47,487 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1620, xmax:1649), (ymin:583, ymax:729)
2025-09-13 16:34:47,658 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 543 order: 1:
2025-09-13 16:34:47,658 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:229, xmax:260), (ymin:441, ymax:592)
2025-09-13 16:34:47,830 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 1188 order: 1:
2025-09-13 16:34:47,830 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:540, xmax:557), (ymin:1383, ymax:1545)
2025-09-13 16:34:48,003 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 533 order: 1:
2025-09-13 16:34:48,004 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1416, xmax:1441), (ymin:433, ymax:576)
2025-09-13 16:34:48,178 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 1342 order: 1:
2025-09-13 16:34:48,178 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1483, xmax:1504), (ymin:1628, ymax:1774)
2025-09-13 16:34:48,348 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 1278 order: 1:
2025-09-13 16:34:48,348 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1077, xmax:1108), (ymin:1531, ymax:1677)
2025-09-13 16:34:50,860 - jwst.extract_2d.grisms - INFO - Finished extractions
2025-09-13 16:34:50,889 - stpipe.Spec2Pipeline.extract_2d - INFO - Step extract_2d done
2025-09-13 16:34:51,288 - stpipe.Spec2Pipeline.srctype - INFO - Step srctype running with args (<MultiSlitModel from jw02079004003_03101_00003_nis_rate.fits>,).
2025-09-13 16:34:51,295 - jwst.srctype.srctype - INFO - Input EXP_TYPE is NIS_WFSS
2025-09-13 16:34:51,296 - jwst.srctype.srctype - INFO - source_id=522, type=EXTENDED
2025-09-13 16:34:51,297 - jwst.srctype.srctype - INFO - source_id=796, type=EXTENDED
2025-09-13 16:34:51,297 - jwst.srctype.srctype - INFO - source_id=1479, type=EXTENDED
2025-09-13 16:34:51,298 - jwst.srctype.srctype - INFO - source_id=214, type=EXTENDED
2025-09-13 16:34:51,298 - jwst.srctype.srctype - INFO - source_id=693, type=EXTENDED
2025-09-13 16:34:51,299 - jwst.srctype.srctype - INFO - source_id=1120, type=EXTENDED
2025-09-13 16:34:51,300 - jwst.srctype.srctype - INFO - source_id=1257, type=EXTENDED
2025-09-13 16:34:51,300 - jwst.srctype.srctype - INFO - source_id=766, type=EXTENDED
2025-09-13 16:34:51,301 - jwst.srctype.srctype - INFO - source_id=606, type=POINT
2025-09-13 16:34:51,302 - jwst.srctype.srctype - INFO - source_id=649, type=EXTENDED
2025-09-13 16:34:51,302 - jwst.srctype.srctype - INFO - source_id=982, type=EXTENDED
2025-09-13 16:34:51,303 - jwst.srctype.srctype - INFO - source_id=1364, type=EXTENDED
2025-09-13 16:34:51,303 - jwst.srctype.srctype - INFO - source_id=898, type=POINT
2025-09-13 16:34:51,304 - jwst.srctype.srctype - INFO - source_id=1049, type=EXTENDED
2025-09-13 16:34:51,304 - jwst.srctype.srctype - INFO - source_id=732, type=EXTENDED
2025-09-13 16:34:51,305 - jwst.srctype.srctype - INFO - source_id=189, type=EXTENDED
2025-09-13 16:34:51,306 - jwst.srctype.srctype - INFO - source_id=881, type=POINT
2025-09-13 16:34:51,306 - jwst.srctype.srctype - INFO - source_id=966, type=EXTENDED
2025-09-13 16:34:51,307 - jwst.srctype.srctype - INFO - source_id=914, type=EXTENDED
2025-09-13 16:34:51,307 - jwst.srctype.srctype - INFO - source_id=1084, type=POINT
2025-09-13 16:34:51,308 - jwst.srctype.srctype - INFO - source_id=540, type=EXTENDED
2025-09-13 16:34:51,308 - jwst.srctype.srctype - INFO - source_id=1476, type=EXTENDED
2025-09-13 16:34:51,309 - jwst.srctype.srctype - INFO - source_id=1142, type=EXTENDED
2025-09-13 16:34:51,310 - jwst.srctype.srctype - INFO - source_id=220, type=POINT
2025-09-13 16:34:51,310 - jwst.srctype.srctype - INFO - source_id=289, type=EXTENDED
2025-09-13 16:34:51,311 - jwst.srctype.srctype - INFO - source_id=934, type=EXTENDED
2025-09-13 16:34:51,311 - jwst.srctype.srctype - INFO - source_id=1219, type=EXTENDED
2025-09-13 16:34:51,312 - jwst.srctype.srctype - INFO - source_id=927, type=EXTENDED
2025-09-13 16:34:51,313 - jwst.srctype.srctype - INFO - source_id=1417, type=EXTENDED
2025-09-13 16:34:51,313 - jwst.srctype.srctype - INFO - source_id=567, type=EXTENDED
2025-09-13 16:34:51,314 - jwst.srctype.srctype - INFO - source_id=1296, type=EXTENDED
2025-09-13 16:34:51,314 - jwst.srctype.srctype - INFO - source_id=1412, type=EXTENDED
2025-09-13 16:34:51,315 - jwst.srctype.srctype - INFO - source_id=654, type=EXTENDED
2025-09-13 16:34:51,316 - jwst.srctype.srctype - INFO - source_id=1029, type=EXTENDED
2025-09-13 16:34:51,316 - jwst.srctype.srctype - INFO - source_id=553, type=EXTENDED
2025-09-13 16:34:51,317 - jwst.srctype.srctype - INFO - source_id=1387, type=EXTENDED
2025-09-13 16:34:51,318 - jwst.srctype.srctype - INFO - source_id=422, type=EXTENDED
2025-09-13 16:34:51,318 - jwst.srctype.srctype - INFO - source_id=821, type=EXTENDED
2025-09-13 16:34:51,319 - jwst.srctype.srctype - INFO - source_id=682, type=EXTENDED
2025-09-13 16:34:51,319 - jwst.srctype.srctype - INFO - source_id=1140, type=EXTENDED
2025-09-13 16:34:51,320 - jwst.srctype.srctype - INFO - source_id=1388, type=EXTENDED
2025-09-13 16:34:51,320 - jwst.srctype.srctype - INFO - source_id=759, type=EXTENDED
2025-09-13 16:34:51,321 - jwst.srctype.srctype - INFO - source_id=1407, type=EXTENDED
2025-09-13 16:34:51,322 - jwst.srctype.srctype - INFO - source_id=1194, type=EXTENDED
2025-09-13 16:34:51,322 - jwst.srctype.srctype - INFO - source_id=712, type=EXTENDED
2025-09-13 16:34:51,323 - jwst.srctype.srctype - INFO - source_id=539, type=EXTENDED
2025-09-13 16:34:51,323 - jwst.srctype.srctype - INFO - source_id=1008, type=EXTENDED
2025-09-13 16:34:51,324 - jwst.srctype.srctype - INFO - source_id=347, type=POINT
2025-09-13 16:34:51,324 - jwst.srctype.srctype - INFO - source_id=276, type=EXTENDED
2025-09-13 16:34:51,325 - jwst.srctype.srctype - INFO - source_id=605, type=POINT
2025-09-13 16:34:51,326 - jwst.srctype.srctype - INFO - source_id=922, type=EXTENDED
2025-09-13 16:34:51,326 - jwst.srctype.srctype - INFO - source_id=736, type=EXTENDED
2025-09-13 16:34:51,327 - jwst.srctype.srctype - INFO - source_id=1423, type=EXTENDED
2025-09-13 16:34:51,328 - jwst.srctype.srctype - INFO - source_id=800, type=EXTENDED
2025-09-13 16:34:51,329 - jwst.srctype.srctype - INFO - source_id=873, type=EXTENDED
2025-09-13 16:34:51,329 - jwst.srctype.srctype - INFO - source_id=385, type=EXTENDED
2025-09-13 16:34:51,330 - jwst.srctype.srctype - INFO - source_id=557, type=EXTENDED
2025-09-13 16:34:51,330 - jwst.srctype.srctype - INFO - source_id=719, type=EXTENDED
2025-09-13 16:34:51,331 - jwst.srctype.srctype - INFO - source_id=389, type=EXTENDED
2025-09-13 16:34:51,332 - jwst.srctype.srctype - INFO - source_id=733, type=EXTENDED
2025-09-13 16:34:51,332 - jwst.srctype.srctype - INFO - source_id=1442, type=EXTENDED
2025-09-13 16:34:51,333 - jwst.srctype.srctype - INFO - source_id=417, type=EXTENDED
2025-09-13 16:34:51,333 - jwst.srctype.srctype - INFO - source_id=630, type=POINT
2025-09-13 16:34:51,334 - jwst.srctype.srctype - INFO - source_id=925, type=EXTENDED
2025-09-13 16:34:51,335 - jwst.srctype.srctype - INFO - source_id=527, type=EXTENDED
2025-09-13 16:34:51,336 - jwst.srctype.srctype - INFO - source_id=439, type=POINT
2025-09-13 16:34:51,336 - jwst.srctype.srctype - INFO - source_id=1253, type=EXTENDED
2025-09-13 16:34:51,337 - jwst.srctype.srctype - INFO - source_id=1162, type=EXTENDED
2025-09-13 16:34:51,337 - jwst.srctype.srctype - INFO - source_id=1457, type=EXTENDED
2025-09-13 16:34:51,338 - jwst.srctype.srctype - INFO - source_id=694, type=EXTENDED
2025-09-13 16:34:51,339 - jwst.srctype.srctype - INFO - source_id=1266, type=EXTENDED
2025-09-13 16:34:51,339 - jwst.srctype.srctype - INFO - source_id=298, type=EXTENDED
2025-09-13 16:34:51,342 - jwst.srctype.srctype - INFO - source_id=516, type=EXTENDED
2025-09-13 16:34:51,342 - jwst.srctype.srctype - INFO - source_id=973, type=EXTENDED
2025-09-13 16:34:51,343 - jwst.srctype.srctype - INFO - source_id=180, type=EXTENDED
2025-09-13 16:34:51,343 - jwst.srctype.srctype - INFO - source_id=980, type=EXTENDED
2025-09-13 16:34:51,344 - jwst.srctype.srctype - INFO - source_id=263, type=EXTENDED
2025-09-13 16:34:51,345 - jwst.srctype.srctype - INFO - source_id=493, type=EXTENDED
2025-09-13 16:34:51,345 - jwst.srctype.srctype - INFO - source_id=981, type=EXTENDED
2025-09-13 16:34:51,346 - jwst.srctype.srctype - INFO - source_id=1371, type=EXTENDED
2025-09-13 16:34:51,346 - jwst.srctype.srctype - INFO - source_id=536, type=EXTENDED
2025-09-13 16:34:51,347 - jwst.srctype.srctype - INFO - source_id=749, type=EXTENDED
2025-09-13 16:34:51,347 - jwst.srctype.srctype - INFO - source_id=345, type=EXTENDED
2025-09-13 16:34:51,348 - jwst.srctype.srctype - INFO - source_id=721, type=POINT
2025-09-13 16:34:51,348 - jwst.srctype.srctype - INFO - source_id=387, type=EXTENDED
2025-09-13 16:34:51,349 - jwst.srctype.srctype - INFO - source_id=505, type=EXTENDED
2025-09-13 16:34:51,350 - jwst.srctype.srctype - INFO - source_id=566, type=EXTENDED
2025-09-13 16:34:51,350 - jwst.srctype.srctype - INFO - source_id=772, type=EXTENDED
2025-09-13 16:34:51,351 - jwst.srctype.srctype - INFO - source_id=722, type=EXTENDED
2025-09-13 16:34:51,351 - jwst.srctype.srctype - INFO - source_id=872, type=POINT
2025-09-13 16:34:51,352 - jwst.srctype.srctype - INFO - source_id=933, type=EXTENDED
2025-09-13 16:34:51,353 - jwst.srctype.srctype - INFO - source_id=1128, type=POINT
2025-09-13 16:34:51,353 - jwst.srctype.srctype - INFO - source_id=1282, type=EXTENDED
2025-09-13 16:34:51,354 - jwst.srctype.srctype - INFO - source_id=274, type=EXTENDED
2025-09-13 16:34:51,355 - jwst.srctype.srctype - INFO - source_id=641, type=EXTENDED
2025-09-13 16:34:51,355 - jwst.srctype.srctype - INFO - source_id=543, type=EXTENDED
2025-09-13 16:34:51,356 - jwst.srctype.srctype - INFO - source_id=1188, type=EXTENDED
2025-09-13 16:34:51,356 - jwst.srctype.srctype - INFO - source_id=533, type=EXTENDED
2025-09-13 16:34:51,357 - jwst.srctype.srctype - INFO - source_id=1342, type=EXTENDED
2025-09-13 16:34:51,358 - jwst.srctype.srctype - INFO - source_id=1278, type=EXTENDED
2025-09-13 16:34:51,360 - stpipe.Spec2Pipeline.srctype - INFO - Step srctype done
2025-09-13 16:34:51,744 - stpipe.Spec2Pipeline.straylight - INFO - Step straylight running with args (<MultiSlitModel from jw02079004003_03101_00003_nis_rate.fits>,).
2025-09-13 16:34:51,744 - stpipe.Spec2Pipeline.straylight - INFO - Step skipped.
2025-09-13 16:34:52,105 - stpipe.Spec2Pipeline.fringe - INFO - Step fringe running with args (<MultiSlitModel from jw02079004003_03101_00003_nis_rate.fits>,).
2025-09-13 16:34:52,106 - stpipe.Spec2Pipeline.fringe - INFO - Step skipped.
2025-09-13 16:34:52,465 - stpipe.Spec2Pipeline.pathloss - INFO - Step pathloss running with args (<MultiSlitModel from jw02079004003_03101_00003_nis_rate.fits>,).
2025-09-13 16:34:52,465 - stpipe.Spec2Pipeline.pathloss - INFO - Step skipped.
2025-09-13 16:34:52,822 - stpipe.Spec2Pipeline.barshadow - INFO - Step barshadow running with args (<MultiSlitModel from jw02079004003_03101_00003_nis_rate.fits>,).
2025-09-13 16:34:52,823 - stpipe.Spec2Pipeline.barshadow - INFO - Step skipped.
2025-09-13 16:34:53,185 - stpipe.Spec2Pipeline.wfss_contam - INFO - Step wfss_contam running with args (<MultiSlitModel from jw02079004003_03101_00003_nis_rate.fits>,).
2025-09-13 16:34:53,186 - stpipe.Spec2Pipeline.wfss_contam - INFO - Step skipped.
2025-09-13 16:34:53,546 - stpipe.Spec2Pipeline.photom - INFO - Step photom running with args (<MultiSlitModel from jw02079004003_03101_00003_nis_rate.fits>,).
2025-09-13 16:34:54,760 - stpipe.Spec2Pipeline.photom - INFO - Using photom reference file: /home/runner/crds/references/jwst/niriss/jwst_niriss_photom_0041.fits
2025-09-13 16:34:54,761 - stpipe.Spec2Pipeline.photom - INFO - Using area reference file: N/A
2025-09-13 16:34:57,630 - jwst.photom.photom - INFO - Using instrument: NIRISS
2025-09-13 16:34:57,630 - jwst.photom.photom - INFO - detector: NIS
2025-09-13 16:34:57,631 - jwst.photom.photom - INFO - exp_type: NIS_WFSS
2025-09-13 16:34:57,631 - jwst.photom.photom - INFO - filter: GR150R
2025-09-13 16:34:57,632 - jwst.photom.photom - INFO - pupil: F200W
2025-09-13 16:34:57,650 - jwst.photom.photom - INFO - Attempting to obtain PIXAR_SR and PIXAR_A2 values from PHOTOM reference file.
2025-09-13 16:34:57,650 - jwst.photom.photom - INFO - Values for PIXAR_SR and PIXAR_A2 obtained from PHOTOM reference file.
2025-09-13 16:34:57,685 - jwst.photom.photom - INFO - Working on slit 522, order 1
2025-09-13 16:34:57,686 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:34:57,691 - jwst.photom.photom - INFO - Working on slit 796, order 1
2025-09-13 16:34:57,692 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:34:57,696 - jwst.photom.photom - INFO - Working on slit 1479, order 1
2025-09-13 16:34:57,697 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:34:57,700 - jwst.photom.photom - INFO - Working on slit 214, order 1
2025-09-13 16:34:57,701 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:34:57,705 - jwst.photom.photom - INFO - Working on slit 693, order 1
2025-09-13 16:34:57,706 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:34:57,709 - jwst.photom.photom - INFO - Working on slit 1120, order 1
2025-09-13 16:34:57,710 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:34:57,714 - jwst.photom.photom - INFO - Working on slit 1257, order 1
2025-09-13 16:34:57,715 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:34:57,719 - jwst.photom.photom - INFO - Working on slit 766, order 1
2025-09-13 16:34:57,720 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:34:57,724 - jwst.photom.photom - INFO - Working on slit 606, order 1
2025-09-13 16:34:57,724 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:34:57,728 - jwst.photom.photom - INFO - Working on slit 649, order 1
2025-09-13 16:34:57,728 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:34:57,732 - jwst.photom.photom - INFO - Working on slit 982, order 1
2025-09-13 16:34:57,733 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:34:57,737 - jwst.photom.photom - INFO - Working on slit 1364, order 1
2025-09-13 16:34:57,737 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:34:57,741 - jwst.photom.photom - INFO - Working on slit 898, order 1
2025-09-13 16:34:57,742 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:34:57,745 - jwst.photom.photom - INFO - Working on slit 1049, order 1
2025-09-13 16:34:57,746 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:34:57,749 - jwst.photom.photom - INFO - Working on slit 732, order 1
2025-09-13 16:34:57,750 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:34:57,753 - jwst.photom.photom - INFO - Working on slit 189, order 1
2025-09-13 16:34:57,754 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:34:57,758 - jwst.photom.photom - INFO - Working on slit 881, order 1
2025-09-13 16:34:57,758 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:34:57,762 - jwst.photom.photom - INFO - Working on slit 966, order 1
2025-09-13 16:34:57,762 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:34:57,766 - jwst.photom.photom - INFO - Working on slit 914, order 1
2025-09-13 16:34:57,767 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:34:57,770 - jwst.photom.photom - INFO - Working on slit 1084, order 1
2025-09-13 16:34:57,771 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:34:57,774 - jwst.photom.photom - INFO - Working on slit 540, order 1
2025-09-13 16:34:57,775 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:34:57,779 - jwst.photom.photom - INFO - Working on slit 1476, order 1
2025-09-13 16:34:57,780 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:34:57,783 - jwst.photom.photom - INFO - Working on slit 1142, order 1
2025-09-13 16:34:57,784 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:34:57,788 - jwst.photom.photom - INFO - Working on slit 220, order 1
2025-09-13 16:34:57,789 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:34:57,792 - jwst.photom.photom - INFO - Working on slit 289, order 1
2025-09-13 16:34:57,793 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:34:57,796 - jwst.photom.photom - INFO - Working on slit 934, order 1
2025-09-13 16:34:57,797 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:34:57,800 - jwst.photom.photom - INFO - Working on slit 1219, order 1
2025-09-13 16:34:57,801 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:34:57,805 - jwst.photom.photom - INFO - Working on slit 927, order 1
2025-09-13 16:34:57,806 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:34:57,809 - jwst.photom.photom - INFO - Working on slit 1417, order 1
2025-09-13 16:34:57,810 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:34:57,813 - jwst.photom.photom - INFO - Working on slit 567, order 1
2025-09-13 16:34:57,814 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:34:57,817 - jwst.photom.photom - INFO - Working on slit 1296, order 1
2025-09-13 16:34:57,818 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:34:57,822 - jwst.photom.photom - INFO - Working on slit 1412, order 1
2025-09-13 16:34:57,822 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:34:57,826 - jwst.photom.photom - INFO - Working on slit 654, order 1
2025-09-13 16:34:57,827 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:34:57,830 - jwst.photom.photom - INFO - Working on slit 1029, order 1
2025-09-13 16:34:57,831 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:34:57,835 - jwst.photom.photom - INFO - Working on slit 553, order 1
2025-09-13 16:34:57,835 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:34:57,839 - jwst.photom.photom - INFO - Working on slit 1387, order 1
2025-09-13 16:34:57,840 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:34:57,843 - jwst.photom.photom - INFO - Working on slit 422, order 1
2025-09-13 16:34:57,844 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:34:57,848 - jwst.photom.photom - INFO - Working on slit 821, order 1
2025-09-13 16:34:57,848 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:34:57,852 - jwst.photom.photom - INFO - Working on slit 682, order 1
2025-09-13 16:34:57,853 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:34:57,856 - jwst.photom.photom - INFO - Working on slit 1140, order 1
2025-09-13 16:34:57,857 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:34:57,860 - jwst.photom.photom - INFO - Working on slit 1388, order 1
2025-09-13 16:34:57,861 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:34:57,865 - jwst.photom.photom - INFO - Working on slit 759, order 1
2025-09-13 16:34:57,865 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:34:57,869 - jwst.photom.photom - INFO - Working on slit 1407, order 1
2025-09-13 16:34:57,870 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:34:57,873 - jwst.photom.photom - INFO - Working on slit 1194, order 1
2025-09-13 16:34:57,874 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:34:57,877 - jwst.photom.photom - INFO - Working on slit 712, order 1
2025-09-13 16:34:57,878 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:34:57,882 - jwst.photom.photom - INFO - Working on slit 539, order 1
2025-09-13 16:34:57,882 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:34:57,886 - jwst.photom.photom - INFO - Working on slit 1008, order 1
2025-09-13 16:34:57,886 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:34:57,890 - jwst.photom.photom - INFO - Working on slit 347, order 1
2025-09-13 16:34:57,891 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:34:57,894 - jwst.photom.photom - INFO - Working on slit 276, order 1
2025-09-13 16:34:57,895 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:34:57,898 - jwst.photom.photom - INFO - Working on slit 605, order 1
2025-09-13 16:34:57,899 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:34:57,902 - jwst.photom.photom - INFO - Working on slit 922, order 1
2025-09-13 16:34:57,903 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:34:57,907 - jwst.photom.photom - INFO - Working on slit 736, order 1
2025-09-13 16:34:57,907 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:34:57,911 - jwst.photom.photom - INFO - Working on slit 1423, order 1
2025-09-13 16:34:57,912 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:34:57,915 - jwst.photom.photom - INFO - Working on slit 800, order 1
2025-09-13 16:34:57,916 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:34:57,920 - jwst.photom.photom - INFO - Working on slit 873, order 1
2025-09-13 16:34:57,920 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:34:57,924 - jwst.photom.photom - INFO - Working on slit 385, order 1
2025-09-13 16:34:57,925 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:34:57,928 - jwst.photom.photom - INFO - Working on slit 557, order 1
2025-09-13 16:34:57,929 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:34:57,932 - jwst.photom.photom - INFO - Working on slit 719, order 1
2025-09-13 16:34:57,933 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:34:57,936 - jwst.photom.photom - INFO - Working on slit 389, order 1
2025-09-13 16:34:57,937 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:34:57,940 - jwst.photom.photom - INFO - Working on slit 733, order 1
2025-09-13 16:34:57,941 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:34:57,945 - jwst.photom.photom - INFO - Working on slit 1442, order 1
2025-09-13 16:34:57,946 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:34:57,949 - jwst.photom.photom - INFO - Working on slit 417, order 1
2025-09-13 16:34:57,950 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:34:57,953 - jwst.photom.photom - INFO - Working on slit 630, order 1
2025-09-13 16:34:57,954 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:34:57,957 - jwst.photom.photom - INFO - Working on slit 925, order 1
2025-09-13 16:34:57,958 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:34:57,962 - jwst.photom.photom - INFO - Working on slit 527, order 1
2025-09-13 16:34:57,962 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:34:57,966 - jwst.photom.photom - INFO - Working on slit 439, order 1
2025-09-13 16:34:57,966 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:34:57,970 - jwst.photom.photom - INFO - Working on slit 1253, order 1
2025-09-13 16:34:57,971 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:34:57,974 - jwst.photom.photom - INFO - Working on slit 1162, order 1
2025-09-13 16:34:57,975 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:34:57,978 - jwst.photom.photom - INFO - Working on slit 1457, order 1
2025-09-13 16:34:57,979 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:34:57,982 - jwst.photom.photom - INFO - Working on slit 694, order 1
2025-09-13 16:34:57,983 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:34:57,986 - jwst.photom.photom - INFO - Working on slit 1266, order 1
2025-09-13 16:34:57,987 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:34:57,991 - jwst.photom.photom - INFO - Working on slit 298, order 1
2025-09-13 16:34:57,991 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:34:57,995 - jwst.photom.photom - INFO - Working on slit 516, order 1
2025-09-13 16:34:57,995 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:34:57,999 - jwst.photom.photom - INFO - Working on slit 973, order 1
2025-09-13 16:34:58,000 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:34:58,003 - jwst.photom.photom - INFO - Working on slit 180, order 1
2025-09-13 16:34:58,004 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:34:58,008 - jwst.photom.photom - INFO - Working on slit 980, order 1
2025-09-13 16:34:58,008 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:34:58,012 - jwst.photom.photom - INFO - Working on slit 263, order 1
2025-09-13 16:34:58,012 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:34:58,016 - jwst.photom.photom - INFO - Working on slit 493, order 1
2025-09-13 16:34:58,017 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:34:58,020 - jwst.photom.photom - INFO - Working on slit 981, order 1
2025-09-13 16:34:58,020 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:34:58,024 - jwst.photom.photom - INFO - Working on slit 1371, order 1
2025-09-13 16:34:58,025 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:34:58,028 - jwst.photom.photom - INFO - Working on slit 536, order 1
2025-09-13 16:34:58,029 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:34:58,032 - jwst.photom.photom - INFO - Working on slit 749, order 1
2025-09-13 16:34:58,033 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:34:58,036 - jwst.photom.photom - INFO - Working on slit 345, order 1
2025-09-13 16:34:58,037 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:34:58,040 - jwst.photom.photom - INFO - Working on slit 721, order 1
2025-09-13 16:34:58,041 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:34:58,045 - jwst.photom.photom - INFO - Working on slit 387, order 1
2025-09-13 16:34:58,045 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:34:58,048 - jwst.photom.photom - INFO - Working on slit 505, order 1
2025-09-13 16:34:58,049 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:34:58,053 - jwst.photom.photom - INFO - Working on slit 566, order 1
2025-09-13 16:34:58,053 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:34:58,057 - jwst.photom.photom - INFO - Working on slit 772, order 1
2025-09-13 16:34:58,057 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:34:58,061 - jwst.photom.photom - INFO - Working on slit 722, order 1
2025-09-13 16:34:58,062 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:34:58,065 - jwst.photom.photom - INFO - Working on slit 872, order 1
2025-09-13 16:34:58,066 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:34:58,069 - jwst.photom.photom - INFO - Working on slit 933, order 1
2025-09-13 16:34:58,070 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:34:58,073 - jwst.photom.photom - INFO - Working on slit 1128, order 1
2025-09-13 16:34:58,074 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:34:58,078 - jwst.photom.photom - INFO - Working on slit 1282, order 1
2025-09-13 16:34:58,078 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:34:58,082 - jwst.photom.photom - INFO - Working on slit 274, order 1
2025-09-13 16:34:58,082 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:34:58,086 - jwst.photom.photom - INFO - Working on slit 641, order 1
2025-09-13 16:34:58,086 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:34:58,090 - jwst.photom.photom - INFO - Working on slit 543, order 1
2025-09-13 16:34:58,090 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:34:58,094 - jwst.photom.photom - INFO - Working on slit 1188, order 1
2025-09-13 16:34:58,094 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:34:58,098 - jwst.photom.photom - INFO - Working on slit 533, order 1
2025-09-13 16:34:58,099 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:34:58,102 - jwst.photom.photom - INFO - Working on slit 1342, order 1
2025-09-13 16:34:58,103 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:34:58,106 - jwst.photom.photom - INFO - Working on slit 1278, order 1
2025-09-13 16:34:58,107 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:34:58,114 - stpipe.Spec2Pipeline.photom - INFO - Step photom done
2025-09-13 16:35:01,364 - stpipe.Spec2Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<MultiSlitModel from /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage2_spec/jw02079004003_03101_00003_nis_cal.fits>,).
2025-09-13 16:35:01,365 - stpipe.Spec2Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 16:35:04,647 - stpipe.Spec2Pipeline.extract_1d - INFO - Step extract_1d running with args (<MultiSlitModel from /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage2_spec/jw02079004003_03101_00003_nis_cal.fits>,).
2025-09-13 16:35:05,110 - stpipe.Spec2Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 16:35:05,169 - jwst.extract_1d.extract - INFO - Working on slit 522
2025-09-13 16:35:05,170 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:35:05,171 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 147.00 (inclusive)
2025-09-13 16:35:05,229 - jwst.extract_1d.extract - INFO - Working on slit 796
2025-09-13 16:35:05,230 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:35:05,231 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 94.00 (inclusive)
2025-09-13 16:35:05,285 - jwst.extract_1d.extract - INFO - Working on slit 1479
2025-09-13 16:35:05,286 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:35:05,287 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 101.00 (inclusive)
2025-09-13 16:35:05,341 - jwst.extract_1d.extract - INFO - Working on slit 214
2025-09-13 16:35:05,342 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:35:05,343 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 84.00 (inclusive)
2025-09-13 16:35:05,396 - jwst.extract_1d.extract - INFO - Working on slit 693
2025-09-13 16:35:05,397 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:35:05,398 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 70.00 (inclusive)
2025-09-13 16:35:05,451 - jwst.extract_1d.extract - INFO - Working on slit 1120
2025-09-13 16:35:05,453 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:35:05,454 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 108.00 (inclusive)
2025-09-13 16:35:05,507 - jwst.extract_1d.extract - INFO - Working on slit 1257
2025-09-13 16:35:05,508 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:35:05,509 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 102.00 (inclusive)
2025-09-13 16:35:05,563 - jwst.extract_1d.extract - INFO - Working on slit 766
2025-09-13 16:35:05,564 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:35:05,565 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 51.00 (inclusive)
2025-09-13 16:35:05,619 - jwst.extract_1d.extract - INFO - Working on slit 606
2025-09-13 16:35:05,620 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type POINT
2025-09-13 16:35:05,620 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 10.00 (inclusive)
2025-09-13 16:35:05,627 - jwst.extract_1d.extract - INFO - Creating aperture correction.
2025-09-13 16:35:05,768 - jwst.extract_1d.extract - INFO - Working on slit 649
2025-09-13 16:35:05,769 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:35:05,770 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 89.00 (inclusive)
2025-09-13 16:35:05,823 - jwst.extract_1d.extract - INFO - Working on slit 982
2025-09-13 16:35:05,825 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:35:05,825 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 48.00 (inclusive)
2025-09-13 16:35:05,878 - jwst.extract_1d.extract - INFO - Working on slit 1364
2025-09-13 16:35:05,879 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:35:05,880 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 43.00 (inclusive)
2025-09-13 16:35:05,933 - jwst.extract_1d.extract - INFO - Working on slit 898
2025-09-13 16:35:05,934 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type POINT
2025-09-13 16:35:05,935 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 10.00 (inclusive)
2025-09-13 16:35:05,942 - jwst.extract_1d.extract - INFO - Creating aperture correction.
2025-09-13 16:35:06,091 - jwst.extract_1d.extract - INFO - Working on slit 1049
2025-09-13 16:35:06,092 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:35:06,093 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 7.00 (inclusive)
2025-09-13 16:35:06,147 - jwst.extract_1d.extract - INFO - Working on slit 732
2025-09-13 16:35:06,148 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:35:06,149 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 64.00 (inclusive)
2025-09-13 16:35:06,203 - jwst.extract_1d.extract - INFO - Working on slit 189
2025-09-13 16:35:06,204 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:35:06,205 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 47.00 (inclusive)
2025-09-13 16:35:06,258 - jwst.extract_1d.extract - INFO - Working on slit 881
2025-09-13 16:35:06,259 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type POINT
2025-09-13 16:35:06,260 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 10.00 (inclusive)
2025-09-13 16:35:06,267 - jwst.extract_1d.extract - INFO - Creating aperture correction.
2025-09-13 16:35:06,405 - jwst.extract_1d.extract - INFO - Working on slit 966
2025-09-13 16:35:06,406 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:35:06,407 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 54.00 (inclusive)
2025-09-13 16:35:06,461 - jwst.extract_1d.extract - INFO - Working on slit 914
2025-09-13 16:35:06,462 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:35:06,463 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 43.00 (inclusive)
2025-09-13 16:35:06,516 - jwst.extract_1d.extract - INFO - Working on slit 1084
2025-09-13 16:35:06,517 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type POINT
2025-09-13 16:35:06,518 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 10.00 (inclusive)
2025-09-13 16:35:06,525 - jwst.extract_1d.extract - INFO - Creating aperture correction.
2025-09-13 16:35:06,653 - jwst.extract_1d.extract - INFO - Working on slit 540
2025-09-13 16:35:06,654 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:35:06,655 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 62.00 (inclusive)
2025-09-13 16:35:06,708 - jwst.extract_1d.extract - INFO - Working on slit 1476
2025-09-13 16:35:06,710 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:35:06,711 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 32.00 (inclusive)
2025-09-13 16:35:06,763 - jwst.extract_1d.extract - INFO - Working on slit 1142
2025-09-13 16:35:06,764 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:35:06,765 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 43.00 (inclusive)
2025-09-13 16:35:06,817 - jwst.extract_1d.extract - INFO - Working on slit 220
2025-09-13 16:35:06,818 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type POINT
2025-09-13 16:35:06,819 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 10.00 (inclusive)
2025-09-13 16:35:06,826 - jwst.extract_1d.extract - INFO - Creating aperture correction.
2025-09-13 16:35:06,959 - jwst.extract_1d.extract - INFO - Working on slit 289
2025-09-13 16:35:06,960 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:35:06,961 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 48.00 (inclusive)
2025-09-13 16:35:07,014 - jwst.extract_1d.extract - INFO - Working on slit 934
2025-09-13 16:35:07,016 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:35:07,017 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 50.00 (inclusive)
2025-09-13 16:35:07,071 - jwst.extract_1d.extract - INFO - Working on slit 1219
2025-09-13 16:35:07,072 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:35:07,073 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 45.00 (inclusive)
2025-09-13 16:35:07,127 - jwst.extract_1d.extract - INFO - Working on slit 927
2025-09-13 16:35:07,128 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:35:07,129 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 52.00 (inclusive)
2025-09-13 16:35:07,183 - jwst.extract_1d.extract - INFO - Working on slit 1417
2025-09-13 16:35:07,184 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:35:07,185 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 38.00 (inclusive)
2025-09-13 16:35:07,237 - jwst.extract_1d.extract - INFO - Working on slit 567
2025-09-13 16:35:07,238 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:35:07,239 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 45.00 (inclusive)
2025-09-13 16:35:07,292 - jwst.extract_1d.extract - INFO - Working on slit 1296
2025-09-13 16:35:07,293 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:35:07,294 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 41.00 (inclusive)
2025-09-13 16:35:07,346 - jwst.extract_1d.extract - INFO - Working on slit 1412
2025-09-13 16:35:07,347 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:35:07,348 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 39.00 (inclusive)
2025-09-13 16:35:07,400 - jwst.extract_1d.extract - INFO - Working on slit 654
2025-09-13 16:35:07,401 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:35:07,402 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 65.00 (inclusive)
2025-09-13 16:35:07,455 - jwst.extract_1d.extract - INFO - Working on slit 1029
2025-09-13 16:35:07,456 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:35:07,457 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 73.00 (inclusive)
2025-09-13 16:35:07,508 - jwst.extract_1d.extract - INFO - Working on slit 553
2025-09-13 16:35:07,510 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:35:07,510 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 47.00 (inclusive)
2025-09-13 16:35:07,562 - jwst.extract_1d.extract - INFO - Working on slit 1387
2025-09-13 16:35:07,563 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:35:07,564 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 38.00 (inclusive)
2025-09-13 16:35:07,617 - jwst.extract_1d.extract - INFO - Working on slit 422
2025-09-13 16:35:07,618 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:35:07,618 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 31.00 (inclusive)
2025-09-13 16:35:07,670 - jwst.extract_1d.extract - INFO - Working on slit 821
2025-09-13 16:35:07,671 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:35:07,672 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 36.00 (inclusive)
2025-09-13 16:35:07,723 - jwst.extract_1d.extract - INFO - Working on slit 682
2025-09-13 16:35:07,725 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:35:07,726 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 41.00 (inclusive)
2025-09-13 16:35:07,778 - jwst.extract_1d.extract - INFO - Working on slit 1140
2025-09-13 16:35:07,779 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:35:07,780 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 48.00 (inclusive)
2025-09-13 16:35:07,832 - jwst.extract_1d.extract - INFO - Working on slit 1388
2025-09-13 16:35:07,833 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:35:07,834 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 51.00 (inclusive)
2025-09-13 16:35:07,886 - jwst.extract_1d.extract - INFO - Working on slit 759
2025-09-13 16:35:07,887 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:35:07,888 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 45.00 (inclusive)
2025-09-13 16:35:07,942 - jwst.extract_1d.extract - INFO - Working on slit 1407
2025-09-13 16:35:07,943 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:35:07,944 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 41.00 (inclusive)
2025-09-13 16:35:07,996 - jwst.extract_1d.extract - INFO - Working on slit 1194
2025-09-13 16:35:07,997 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:35:07,998 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 41.00 (inclusive)
2025-09-13 16:35:08,051 - jwst.extract_1d.extract - INFO - Working on slit 712
2025-09-13 16:35:08,052 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:35:08,053 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 40.00 (inclusive)
2025-09-13 16:35:08,106 - jwst.extract_1d.extract - INFO - Working on slit 539
2025-09-13 16:35:08,107 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:35:08,108 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 27.00 (inclusive)
2025-09-13 16:35:08,161 - jwst.extract_1d.extract - INFO - Working on slit 1008
2025-09-13 16:35:08,162 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:35:08,163 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 31.00 (inclusive)
2025-09-13 16:35:08,215 - jwst.extract_1d.extract - INFO - Working on slit 347
2025-09-13 16:35:08,216 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type POINT
2025-09-13 16:35:08,217 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 10.00 (inclusive)
2025-09-13 16:35:08,224 - jwst.extract_1d.extract - INFO - Creating aperture correction.
2025-09-13 16:35:08,350 - jwst.extract_1d.extract - INFO - Working on slit 276
2025-09-13 16:35:08,351 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:35:08,352 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 43.00 (inclusive)
2025-09-13 16:35:08,404 - jwst.extract_1d.extract - INFO - Working on slit 605
2025-09-13 16:35:08,405 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type POINT
2025-09-13 16:35:08,406 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 10.00 (inclusive)
2025-09-13 16:35:08,413 - jwst.extract_1d.extract - INFO - Creating aperture correction.
2025-09-13 16:35:08,530 - jwst.extract_1d.extract - INFO - Working on slit 922
2025-09-13 16:35:08,531 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:35:08,532 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 30.00 (inclusive)
2025-09-13 16:35:08,585 - jwst.extract_1d.extract - INFO - Working on slit 736
2025-09-13 16:35:08,586 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:35:08,587 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 23.00 (inclusive)
2025-09-13 16:35:08,638 - jwst.extract_1d.extract - INFO - Working on slit 1423
2025-09-13 16:35:08,639 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:35:08,640 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 32.00 (inclusive)
2025-09-13 16:35:08,691 - jwst.extract_1d.extract - INFO - Working on slit 800
2025-09-13 16:35:08,692 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:35:08,693 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 28.00 (inclusive)
2025-09-13 16:35:08,745 - jwst.extract_1d.extract - INFO - Working on slit 873
2025-09-13 16:35:08,746 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:35:08,747 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 22.00 (inclusive)
2025-09-13 16:35:08,798 - jwst.extract_1d.extract - INFO - Working on slit 385
2025-09-13 16:35:08,799 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:35:08,800 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 41.00 (inclusive)
2025-09-13 16:35:08,852 - jwst.extract_1d.extract - INFO - Working on slit 557
2025-09-13 16:35:08,853 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:35:08,854 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 38.00 (inclusive)
2025-09-13 16:35:08,906 - jwst.extract_1d.extract - INFO - Working on slit 719
2025-09-13 16:35:08,908 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:35:08,908 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 24.00 (inclusive)
2025-09-13 16:35:08,960 - jwst.extract_1d.extract - INFO - Working on slit 389
2025-09-13 16:35:08,961 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:35:08,962 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 32.00 (inclusive)
2025-09-13 16:35:09,013 - jwst.extract_1d.extract - INFO - Working on slit 733
2025-09-13 16:35:09,015 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:35:09,015 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 53.00 (inclusive)
2025-09-13 16:35:09,067 - jwst.extract_1d.extract - INFO - Working on slit 1442
2025-09-13 16:35:09,068 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:35:09,069 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 43.00 (inclusive)
2025-09-13 16:35:09,121 - jwst.extract_1d.extract - INFO - Working on slit 417
2025-09-13 16:35:09,122 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:35:09,123 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 25.00 (inclusive)
2025-09-13 16:35:09,175 - jwst.extract_1d.extract - INFO - Working on slit 630
2025-09-13 16:35:09,176 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type POINT
2025-09-13 16:35:09,177 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 10.00 (inclusive)
2025-09-13 16:35:09,183 - jwst.extract_1d.extract - INFO - Creating aperture correction.
2025-09-13 16:35:09,298 - jwst.extract_1d.extract - INFO - Working on slit 925
2025-09-13 16:35:09,299 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:35:09,300 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 42.00 (inclusive)
2025-09-13 16:35:09,352 - jwst.extract_1d.extract - INFO - Working on slit 527
2025-09-13 16:35:09,353 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:35:09,354 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 28.00 (inclusive)
2025-09-13 16:35:09,405 - jwst.extract_1d.extract - INFO - Working on slit 439
2025-09-13 16:35:09,407 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type POINT
2025-09-13 16:35:09,407 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 10.00 (inclusive)
2025-09-13 16:35:09,414 - jwst.extract_1d.extract - INFO - Creating aperture correction.
2025-09-13 16:35:09,536 - jwst.extract_1d.extract - INFO - Working on slit 1253
2025-09-13 16:35:09,537 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:35:09,538 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 24.00 (inclusive)
2025-09-13 16:35:09,589 - jwst.extract_1d.extract - INFO - Working on slit 1162
2025-09-13 16:35:09,590 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:35:09,591 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 21.00 (inclusive)
2025-09-13 16:35:09,642 - jwst.extract_1d.extract - INFO - Working on slit 1457
2025-09-13 16:35:09,643 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:35:09,644 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 23.00 (inclusive)
2025-09-13 16:35:09,696 - jwst.extract_1d.extract - INFO - Working on slit 694
2025-09-13 16:35:09,697 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:35:09,698 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 44.00 (inclusive)
2025-09-13 16:35:09,750 - jwst.extract_1d.extract - INFO - Working on slit 1266
2025-09-13 16:35:09,751 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:35:09,752 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 37.00 (inclusive)
2025-09-13 16:35:09,803 - jwst.extract_1d.extract - INFO - Working on slit 298
2025-09-13 16:35:09,804 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:35:09,805 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 32.00 (inclusive)
2025-09-13 16:35:09,857 - jwst.extract_1d.extract - INFO - Working on slit 516
2025-09-13 16:35:09,858 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:35:09,859 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 30.00 (inclusive)
2025-09-13 16:35:09,912 - jwst.extract_1d.extract - INFO - Working on slit 973
2025-09-13 16:35:09,913 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:35:09,914 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 22.00 (inclusive)
2025-09-13 16:35:09,967 - jwst.extract_1d.extract - INFO - Working on slit 180
2025-09-13 16:35:09,968 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:35:09,969 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 42.00 (inclusive)
2025-09-13 16:35:10,022 - jwst.extract_1d.extract - INFO - Working on slit 980
2025-09-13 16:35:10,023 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:35:10,024 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 40.00 (inclusive)
2025-09-13 16:35:10,075 - jwst.extract_1d.extract - INFO - Working on slit 263
2025-09-13 16:35:10,076 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:35:10,077 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 38.00 (inclusive)
2025-09-13 16:35:10,129 - jwst.extract_1d.extract - INFO - Working on slit 493
2025-09-13 16:35:10,130 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:35:10,131 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 30.00 (inclusive)
2025-09-13 16:35:10,183 - jwst.extract_1d.extract - INFO - Working on slit 981
2025-09-13 16:35:10,184 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:35:10,185 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 20.00 (inclusive)
2025-09-13 16:35:10,237 - jwst.extract_1d.extract - INFO - Working on slit 1371
2025-09-13 16:35:10,238 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:35:10,239 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 23.00 (inclusive)
2025-09-13 16:35:10,291 - jwst.extract_1d.extract - INFO - Working on slit 536
2025-09-13 16:35:10,292 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:35:10,292 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 23.00 (inclusive)
2025-09-13 16:35:10,345 - jwst.extract_1d.extract - INFO - Working on slit 749
2025-09-13 16:35:10,346 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:35:10,347 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 25.00 (inclusive)
2025-09-13 16:35:10,399 - jwst.extract_1d.extract - INFO - Working on slit 345
2025-09-13 16:35:10,400 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:35:10,401 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 21.00 (inclusive)
2025-09-13 16:35:10,453 - jwst.extract_1d.extract - INFO - Working on slit 721
2025-09-13 16:35:10,454 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type POINT
2025-09-13 16:35:10,455 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 10.00 (inclusive)
2025-09-13 16:35:10,462 - jwst.extract_1d.extract - INFO - Creating aperture correction.
2025-09-13 16:35:10,578 - jwst.extract_1d.extract - INFO - Working on slit 387
2025-09-13 16:35:10,579 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:35:10,580 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 24.00 (inclusive)
2025-09-13 16:35:10,634 - jwst.extract_1d.extract - INFO - Working on slit 505
2025-09-13 16:35:10,635 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:35:10,635 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 22.00 (inclusive)
2025-09-13 16:35:10,688 - jwst.extract_1d.extract - INFO - Working on slit 566
2025-09-13 16:35:10,689 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:35:10,690 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 23.00 (inclusive)
2025-09-13 16:35:10,743 - jwst.extract_1d.extract - INFO - Working on slit 772
2025-09-13 16:35:10,744 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:35:10,745 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 26.00 (inclusive)
2025-09-13 16:35:10,797 - jwst.extract_1d.extract - INFO - Working on slit 722
2025-09-13 16:35:10,798 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:35:10,798 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 31.00 (inclusive)
2025-09-13 16:35:10,850 - jwst.extract_1d.extract - INFO - Working on slit 872
2025-09-13 16:35:10,851 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type POINT
2025-09-13 16:35:10,852 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 10.00 (inclusive)
2025-09-13 16:35:10,859 - jwst.extract_1d.extract - INFO - Creating aperture correction.
2025-09-13 16:35:10,975 - jwst.extract_1d.extract - INFO - Working on slit 933
2025-09-13 16:35:10,976 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:35:10,977 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 36.00 (inclusive)
2025-09-13 16:35:11,031 - jwst.extract_1d.extract - INFO - Working on slit 1128
2025-09-13 16:35:11,032 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type POINT
2025-09-13 16:35:11,033 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 10.00 (inclusive)
2025-09-13 16:35:11,040 - jwst.extract_1d.extract - INFO - Creating aperture correction.
2025-09-13 16:35:11,153 - jwst.extract_1d.extract - INFO - Working on slit 1282
2025-09-13 16:35:11,154 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:35:11,155 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 34.00 (inclusive)
2025-09-13 16:35:11,209 - jwst.extract_1d.extract - INFO - Working on slit 274
2025-09-13 16:35:11,210 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:35:11,211 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 31.00 (inclusive)
2025-09-13 16:35:11,265 - jwst.extract_1d.extract - INFO - Working on slit 641
2025-09-13 16:35:11,266 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:35:11,267 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 29.00 (inclusive)
2025-09-13 16:35:11,319 - jwst.extract_1d.extract - INFO - Working on slit 543
2025-09-13 16:35:11,320 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:35:11,321 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 31.00 (inclusive)
2025-09-13 16:35:11,375 - jwst.extract_1d.extract - INFO - Working on slit 1188
2025-09-13 16:35:11,376 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:35:11,376 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 17.00 (inclusive)
2025-09-13 16:35:11,430 - jwst.extract_1d.extract - INFO - Working on slit 533
2025-09-13 16:35:11,431 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:35:11,432 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 25.00 (inclusive)
2025-09-13 16:35:11,485 - jwst.extract_1d.extract - INFO - Working on slit 1342
2025-09-13 16:35:11,486 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:35:11,487 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 21.00 (inclusive)
2025-09-13 16:35:11,540 - jwst.extract_1d.extract - INFO - Working on slit 1278
2025-09-13 16:35:11,541 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:35:11,542 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 31.00 (inclusive)
2025-09-13 16:35:11,873 - stpipe.Spec2Pipeline.extract_1d - INFO - Saved model in /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage2_spec/jw02079004003_03101_00003_nis_x1d.fits
2025-09-13 16:35:11,873 - stpipe.Spec2Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 16:35:11,876 - stpipe.Spec2Pipeline - INFO - Finished processing product /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage1/jw02079004003_03101_00003_nis
2025-09-13 16:35:11,879 - stpipe.Spec2Pipeline - INFO - Ending calwebb_spec2
2025-09-13 16:35:11,879 - jwst.stpipe.core - INFO - Results used CRDS context: jwst_1413.pmap
2025-09-13 16:35:22,917 - stpipe.Spec2Pipeline - INFO - Saved model in /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage2_spec/jw02079004003_03101_00003_nis_cal.fits
2025-09-13 16:35:22,918 - stpipe.Spec2Pipeline - INFO - Step Spec2Pipeline done
2025-09-13 16:35:22,918 - jwst.stpipe.core - INFO - Results used jwst version: 1.19.1
2025-09-13 16:35:22,928 - py.warnings - WARNING - /usr/share/miniconda/lib/python3.13/site-packages/jwst/associations/association.py:234: UserWarning: Input association file contains path information; note that this can complicate usage and/or sharing of such files.
warnings.warn(err_str, UserWarning, stacklevel=1)
2025-09-13 16:35:22,985 - stpipe - INFO - PARS-SPEC2PIPELINE parameters found: /home/runner/crds/references/jwst/niriss/jwst_niriss_pars-spec2pipeline_0005.asdf
2025-09-13 16:35:23,008 - stpipe.Spec2Pipeline - INFO - Spec2Pipeline instance created.
2025-09-13 16:35:23,009 - stpipe.Spec2Pipeline.assign_wcs - INFO - AssignWcsStep instance created.
2025-09-13 16:35:23,010 - stpipe.Spec2Pipeline.badpix_selfcal - INFO - BadpixSelfcalStep instance created.
2025-09-13 16:35:23,011 - stpipe.Spec2Pipeline.msa_flagging - INFO - MSAFlagOpenStep instance created.
2025-09-13 16:35:23,012 - stpipe.Spec2Pipeline.nsclean - INFO - NSCleanStep instance created.
2025-09-13 16:35:23,014 - stpipe.Spec2Pipeline.bkg_subtract - INFO - BackgroundStep instance created.
2025-09-13 16:35:23,015 - stpipe.Spec2Pipeline.imprint_subtract - INFO - ImprintStep instance created.
2025-09-13 16:35:23,016 - stpipe.Spec2Pipeline.extract_2d - INFO - Extract2dStep instance created.
2025-09-13 16:35:23,021 - stpipe.Spec2Pipeline.master_background_mos - INFO - MasterBackgroundMosStep instance created.
2025-09-13 16:35:23,022 - stpipe.Spec2Pipeline.master_background_mos.flat_field - INFO - FlatFieldStep instance created.
2025-09-13 16:35:23,023 - stpipe.Spec2Pipeline.master_background_mos.pathloss - INFO - PathLossStep instance created.
2025-09-13 16:35:23,024 - stpipe.Spec2Pipeline.master_background_mos.barshadow - INFO - BarShadowStep instance created.
2025-09-13 16:35:23,025 - stpipe.Spec2Pipeline.master_background_mos.photom - INFO - PhotomStep instance created.
2025-09-13 16:35:23,026 - stpipe.Spec2Pipeline.master_background_mos.pixel_replace - INFO - PixelReplaceStep instance created.
2025-09-13 16:35:23,027 - stpipe.Spec2Pipeline.master_background_mos.resample_spec - INFO - ResampleSpecStep instance created.
2025-09-13 16:35:23,028 - stpipe.Spec2Pipeline.master_background_mos.extract_1d - INFO - Extract1dStep instance created.
2025-09-13 16:35:23,029 - stpipe.Spec2Pipeline.wavecorr - INFO - WavecorrStep instance created.
2025-09-13 16:35:23,030 - stpipe.Spec2Pipeline.flat_field - INFO - FlatFieldStep instance created.
2025-09-13 16:35:23,031 - stpipe.Spec2Pipeline.srctype - INFO - SourceTypeStep instance created.
2025-09-13 16:35:23,032 - stpipe.Spec2Pipeline.straylight - INFO - StraylightStep instance created.
2025-09-13 16:35:23,032 - stpipe.Spec2Pipeline.fringe - INFO - FringeStep instance created.
2025-09-13 16:35:23,033 - stpipe.Spec2Pipeline.residual_fringe - INFO - ResidualFringeStep instance created.
2025-09-13 16:35:23,035 - stpipe.Spec2Pipeline.pathloss - INFO - PathLossStep instance created.
2025-09-13 16:35:23,036 - stpipe.Spec2Pipeline.barshadow - INFO - BarShadowStep instance created.
2025-09-13 16:35:23,037 - stpipe.Spec2Pipeline.wfss_contam - INFO - WfssContamStep instance created.
2025-09-13 16:35:23,039 - stpipe.Spec2Pipeline.photom - INFO - PhotomStep instance created.
2025-09-13 16:35:23,039 - stpipe.Spec2Pipeline.pixel_replace - INFO - PixelReplaceStep instance created.
2025-09-13 16:35:23,040 - stpipe.Spec2Pipeline.resample_spec - INFO - ResampleSpecStep instance created.
2025-09-13 16:35:23,042 - stpipe.Spec2Pipeline.cube_build - INFO - CubeBuildStep instance created.
2025-09-13 16:35:23,043 - stpipe.Spec2Pipeline.extract_1d - INFO - Extract1dStep instance created.
2025-09-13 16:35:23,404 - stpipe.Spec2Pipeline - INFO - Step Spec2Pipeline running with args ('/home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/jw02079004003_05101_00001_nis_spec2_asn.json',).
2025-09-13 16:35:23,438 - stpipe.Spec2Pipeline - INFO - Step Spec2Pipeline parameters are:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage2_spec
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: True
skip: False
suffix: None
search_output_file: True
input_dir: ''
save_bsub: False
fail_on_exception: True
save_wfss_esec: False
steps:
assign_wcs:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
sip_approx: True
sip_max_pix_error: 0.01
sip_degree: None
sip_max_inv_pix_error: 0.01
sip_inv_degree: None
sip_npoints: 12
slit_y_low: -0.55
slit_y_high: 0.55
nrs_ifu_slice_wcs: False
badpix_selfcal:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: True
suffix: None
search_output_file: True
input_dir: ''
flagfrac_lower: 0.001
flagfrac_upper: 0.001
kernel_size: 15
force_single: False
save_flagged_bkg: False
msa_flagging:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
nsclean:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: True
suffix: None
search_output_file: True
input_dir: ''
fit_method: fft
fit_by_channel: False
background_method: None
background_box_size: None
mask_spectral_regions: True
n_sigma: 5.0
fit_histogram: False
single_mask: False
user_mask: None
save_mask: False
save_background: False
save_noise: False
bkg_subtract:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
bkg_list: None
save_combined_background: False
sigma: 3.0
maxiters: None
soss_source_percentile: 35.0
soss_bkg_percentile: None
wfss_mmag_extract: None
wfss_maxiter: 5
wfss_rms_stop: 0.0
wfss_outlier_percent: 1.0
imprint_subtract:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
extract_2d:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
slit_names: None
source_ids: None
extract_orders: None
grism_objects: None
tsgrism_extract_height: None
wfss_extract_half_height: 5
wfss_mmag_extract: None
wfss_nbright: 100
master_background_mos:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: True
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
sigma_clip: 3.0
median_kernel: 1
force_subtract: False
save_background: False
user_background: None
inverse: False
steps:
flat_field:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
save_interpolated_flat: False
user_supplied_flat: None
inverse: False
pathloss:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
inverse: False
source_type: None
user_slit_loc: None
barshadow:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
inverse: False
source_type: None
photom:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
inverse: False
source_type: None
mrs_time_correction: True
pixel_replace:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: True
output_use_index: True
save_results: False
skip: True
suffix: None
search_output_file: True
input_dir: ''
algorithm: fit_profile
n_adjacent_cols: 3
resample_spec:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
pixfrac: 1.0
kernel: square
fillval: NAN
weight_type: ivm
output_shape: None
pixel_scale_ratio: 1.0
pixel_scale: None
output_wcs: ''
single: False
blendheaders: True
in_memory: True
extract_1d:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
subtract_background: None
apply_apcorr: True
extraction_type: box
use_source_posn: None
position_offset: 0.0
model_nod_pair: True
optimize_psf_location: True
smoothing_length: None
bkg_fit: None
bkg_order: None
log_increment: 50
save_profile: False
save_scene_model: False
save_residual_image: False
center_xy: None
ifu_autocen: False
bkg_sigma_clip: 3.0
ifu_rfcorr: True
ifu_set_srctype: None
ifu_rscale: None
ifu_covar_scale: 1.0
soss_atoca: True
soss_threshold: 0.01
soss_n_os: 2
soss_wave_grid_in: None
soss_wave_grid_out: None
soss_estimate: None
soss_rtol: 0.0001
soss_max_grid_size: 20000
soss_tikfac: None
soss_width: 40.0
soss_bad_pix: masking
soss_modelname: None
wavecorr:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
flat_field:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
save_interpolated_flat: False
user_supplied_flat: None
inverse: False
srctype:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
source_type: None
straylight:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
clean_showers: False
shower_plane: 3
shower_x_stddev: 18.0
shower_y_stddev: 5.0
shower_low_reject: 0.1
shower_high_reject: 99.9
save_shower_model: False
fringe:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
residual_fringe:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: True
suffix: residual_fringe
search_output_file: False
input_dir: ''
save_intermediate_results: False
ignore_region_min: None
ignore_region_max: None
pathloss:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
inverse: False
source_type: None
user_slit_loc: None
barshadow:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
inverse: False
source_type: None
wfss_contam:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: True
suffix: None
search_output_file: True
input_dir: ''
save_simulated_image: False
save_contam_images: False
maximum_cores: none
photom:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
inverse: False
source_type: None
mrs_time_correction: True
pixel_replace:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: True
output_use_index: True
save_results: False
skip: True
suffix: None
search_output_file: True
input_dir: ''
algorithm: fit_profile
n_adjacent_cols: 3
resample_spec:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
pixfrac: 1.0
kernel: square
fillval: NAN
weight_type: ivm
output_shape: None
pixel_scale_ratio: 1.0
pixel_scale: None
output_wcs: ''
single: False
blendheaders: True
in_memory: True
cube_build:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: True
output_use_index: True
save_results: False
skip: False
suffix: s3d
search_output_file: False
input_dir: ''
channel: all
band: all
grating: all
filter: all
output_type: None
scalexy: 0.0
scalew: 0.0
weighting: drizzle
coord_system: skyalign
ra_center: None
dec_center: None
cube_pa: None
nspax_x: None
nspax_y: None
rois: 0.0
roiw: 0.0
weight_power: 2.0
wavemin: None
wavemax: None
single: False
skip_dqflagging: False
offset_file: None
debug_spaxel: -1 -1 -1
extract_1d:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
subtract_background: None
apply_apcorr: True
extraction_type: box
use_source_posn: None
position_offset: 0.0
model_nod_pair: True
optimize_psf_location: True
smoothing_length: None
bkg_fit: None
bkg_order: None
log_increment: 50
save_profile: False
save_scene_model: False
save_residual_image: False
center_xy: None
ifu_autocen: False
bkg_sigma_clip: 3.0
ifu_rfcorr: True
ifu_set_srctype: None
ifu_rscale: None
ifu_covar_scale: 1.0
soss_atoca: True
soss_threshold: 0.01
soss_n_os: 2
soss_wave_grid_in: None
soss_wave_grid_out: None
soss_estimate: None
soss_rtol: 0.0001
soss_max_grid_size: 20000
soss_tikfac: None
soss_width: 40.0
soss_bad_pix: masking
soss_modelname: None
2025-09-13 16:35:23,486 - stpipe.Spec2Pipeline - INFO - Prefetching reference files for dataset: 'jw02079004003_05101_00001_nis_spec2_asn.json' reftypes = ['apcorr', 'area', 'barshadow', 'bkg', 'camera', 'collimator', 'cubepar', 'dflat', 'disperser', 'distortion', 'extract1d', 'fflat', 'filteroffset', 'flat', 'fore', 'fpa', 'fringe', 'ifufore', 'ifupost', 'ifuslicer', 'mrsxartcorr', 'msa', 'msaoper', 'ote', 'pastasoss', 'pathloss', 'photom', 'psf', 'regions', 'sflat', 'speckernel', 'specprofile', 'specwcs', 'wavecorr', 'wavelengthrange']
2025-09-13 16:35:23,489 - CRDS - INFO - Fetching /home/runner/crds/references/jwst/niriss/jwst_niriss_bkg_0027.fits 83.9 M bytes (1 / 3 files) (0 / 151.1 M bytes)
2025-09-13 16:37:37,979 - CRDS - INFO - Fetching /home/runner/crds/references/jwst/niriss/jwst_niriss_flat_0265.fits 67.1 M bytes (2 / 3 files) (83.9 M / 151.1 M bytes)
2025-09-13 16:39:22,071 - CRDS - INFO - Fetching /home/runner/crds/references/jwst/niriss/jwst_niriss_specwcs_0064.asdf 20.9 K bytes (3 / 3 files) (151.0 M / 151.1 M bytes)
2025-09-13 16:39:22,409 - stpipe.Spec2Pipeline - INFO - Prefetch for APCORR reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits'.
2025-09-13 16:39:22,410 - stpipe.Spec2Pipeline - INFO - Prefetch for AREA reference file is 'N/A'.
2025-09-13 16:39:22,410 - stpipe.Spec2Pipeline - INFO - Prefetch for BARSHADOW reference file is 'N/A'.
2025-09-13 16:39:22,411 - stpipe.Spec2Pipeline - INFO - Prefetch for BKG reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_bkg_0027.fits'.
2025-09-13 16:39:22,411 - stpipe.Spec2Pipeline - INFO - Prefetch for CAMERA reference file is 'N/A'.
2025-09-13 16:39:22,412 - stpipe.Spec2Pipeline - INFO - Prefetch for COLLIMATOR reference file is 'N/A'.
2025-09-13 16:39:22,412 - stpipe.Spec2Pipeline - INFO - Prefetch for CUBEPAR reference file is 'N/A'.
2025-09-13 16:39:22,412 - stpipe.Spec2Pipeline - INFO - Prefetch for DFLAT reference file is 'N/A'.
2025-09-13 16:39:22,413 - stpipe.Spec2Pipeline - INFO - Prefetch for DISPERSER reference file is 'N/A'.
2025-09-13 16:39:22,413 - stpipe.Spec2Pipeline - INFO - Prefetch for DISTORTION reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_distortion_0037.asdf'.
2025-09-13 16:39:22,414 - stpipe.Spec2Pipeline - INFO - Prefetch for EXTRACT1D reference file is 'N/A'.
2025-09-13 16:39:22,414 - stpipe.Spec2Pipeline - INFO - Prefetch for FFLAT reference file is 'N/A'.
2025-09-13 16:39:22,414 - stpipe.Spec2Pipeline - INFO - Prefetch for FILTEROFFSET reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_filteroffset_0006.asdf'.
2025-09-13 16:39:22,415 - stpipe.Spec2Pipeline - INFO - Prefetch for FLAT reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_flat_0265.fits'.
2025-09-13 16:39:22,415 - stpipe.Spec2Pipeline - INFO - Prefetch for FORE reference file is 'N/A'.
2025-09-13 16:39:22,416 - stpipe.Spec2Pipeline - INFO - Prefetch for FPA reference file is 'N/A'.
2025-09-13 16:39:22,416 - stpipe.Spec2Pipeline - INFO - Prefetch for FRINGE reference file is 'N/A'.
2025-09-13 16:39:22,416 - stpipe.Spec2Pipeline - INFO - Prefetch for IFUFORE reference file is 'N/A'.
2025-09-13 16:39:22,417 - stpipe.Spec2Pipeline - INFO - Prefetch for IFUPOST reference file is 'N/A'.
2025-09-13 16:39:22,417 - stpipe.Spec2Pipeline - INFO - Prefetch for IFUSLICER reference file is 'N/A'.
2025-09-13 16:39:22,417 - stpipe.Spec2Pipeline - INFO - Prefetch for MRSXARTCORR reference file is 'N/A'.
2025-09-13 16:39:22,418 - stpipe.Spec2Pipeline - INFO - Prefetch for MSA reference file is 'N/A'.
2025-09-13 16:39:22,418 - stpipe.Spec2Pipeline - INFO - Prefetch for MSAOPER reference file is 'N/A'.
2025-09-13 16:39:22,418 - stpipe.Spec2Pipeline - INFO - Prefetch for OTE reference file is 'N/A'.
2025-09-13 16:39:22,418 - stpipe.Spec2Pipeline - INFO - Prefetch for PASTASOSS reference file is 'N/A'.
2025-09-13 16:39:22,419 - stpipe.Spec2Pipeline - INFO - Prefetch for PATHLOSS reference file is 'N/A'.
2025-09-13 16:39:22,419 - stpipe.Spec2Pipeline - INFO - Prefetch for PHOTOM reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_photom_0041.fits'.
2025-09-13 16:39:22,420 - stpipe.Spec2Pipeline - INFO - Prefetch for PSF reference file is 'N/A'.
2025-09-13 16:39:22,420 - stpipe.Spec2Pipeline - INFO - Prefetch for REGIONS reference file is 'N/A'.
2025-09-13 16:39:22,420 - stpipe.Spec2Pipeline - INFO - Prefetch for SFLAT reference file is 'N/A'.
2025-09-13 16:39:22,421 - stpipe.Spec2Pipeline - INFO - Prefetch for SPECKERNEL reference file is 'N/A'.
2025-09-13 16:39:22,421 - stpipe.Spec2Pipeline - INFO - Prefetch for SPECPROFILE reference file is 'N/A'.
2025-09-13 16:39:22,421 - stpipe.Spec2Pipeline - INFO - Prefetch for SPECWCS reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_specwcs_0064.asdf'.
2025-09-13 16:39:22,422 - stpipe.Spec2Pipeline - INFO - Prefetch for WAVECORR reference file is 'N/A'.
2025-09-13 16:39:22,422 - stpipe.Spec2Pipeline - INFO - Prefetch for WAVELENGTHRANGE reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_wavelengthrange_0002.asdf'.
2025-09-13 16:39:22,422 - stpipe.Spec2Pipeline - INFO - Starting calwebb_spec2 ...
2025-09-13 16:39:22,430 - stpipe.Spec2Pipeline - INFO - Processing product /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage1/jw02079004003_05101_00001_nis
2025-09-13 16:39:22,430 - stpipe.Spec2Pipeline - INFO - Working on input /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage1/jw02079004003_05101_00001_nis_rate.fits ...
2025-09-13 16:39:22,478 - stpipe.Spec2Pipeline - INFO - Using sourcecat file jw02079-o004_niriss_clear-f200w_cat.ecsv
2025-09-13 16:39:22,479 - stpipe.Spec2Pipeline - INFO - Using segmentation map jw02079-o004_niriss_clear-f200w_segm.fits
2025-09-13 16:39:22,480 - stpipe.Spec2Pipeline - INFO - Using direct image jw02079-o004_niriss_clear-f200w_i2d.fits
2025-09-13 16:39:22,834 - stpipe.Spec2Pipeline.assign_wcs - INFO - Step assign_wcs running with args (<ImageModel(2048, 2048) from jw02079004003_05101_00001_nis_rate.fits>,).
2025-09-13 16:39:22,950 - jwst.assign_wcs.niriss - INFO - Added Barycentric velocity correction: 0.9999282770225614
2025-09-13 16:39:23,006 - jwst.assign_wcs.niriss - INFO - Offsets from filteroffset file are 2.119, -1.0476
2025-09-13 16:39:23,086 - jwst.assign_wcs.assign_wcs - INFO - COMPLETED assign_wcs
2025-09-13 16:39:23,087 - stpipe.AssignWcsStep - INFO - AssignWcsStep instance created.
2025-09-13 16:39:23,166 - jwst.assign_wcs.niriss - INFO - Offsets from filteroffset file are 2.119, -1.0476
2025-09-13 16:39:23,214 - stpipe.Spec2Pipeline.assign_wcs - INFO - Step assign_wcs done
2025-09-13 16:39:23,579 - stpipe.Spec2Pipeline.badpix_selfcal - INFO - Step badpix_selfcal running with args (<ImageModel(2048, 2048) from jw02079004003_05101_00001_nis_rate.fits>, [], []).
2025-09-13 16:39:23,580 - stpipe.Spec2Pipeline.badpix_selfcal - INFO - Step skipped.
2025-09-13 16:39:23,932 - stpipe.Spec2Pipeline.msa_flagging - INFO - Step msa_flagging running with args (<ImageModel(2048, 2048) from jw02079004003_05101_00001_nis_rate.fits>,).
2025-09-13 16:39:23,933 - stpipe.Spec2Pipeline.msa_flagging - INFO - Step skipped.
2025-09-13 16:39:24,295 - stpipe.Spec2Pipeline.nsclean - INFO - Step nsclean running with args (<ImageModel(2048, 2048) from jw02079004003_05101_00001_nis_rate.fits>,).
2025-09-13 16:39:24,296 - stpipe.Spec2Pipeline.nsclean - INFO - Step skipped.
2025-09-13 16:39:24,655 - stpipe.Spec2Pipeline.imprint_subtract - INFO - Step imprint_subtract running with args (<ImageModel(2048, 2048) from jw02079004003_05101_00001_nis_rate.fits>, []).
2025-09-13 16:39:24,656 - stpipe.Spec2Pipeline.imprint_subtract - INFO - Step skipped.
2025-09-13 16:39:25,031 - stpipe.Spec2Pipeline.bkg_subtract - INFO - Step bkg_subtract running with args (<ImageModel(2048, 2048) from jw02079004003_05101_00001_nis_rate.fits>, []).
2025-09-13 16:39:25,289 - jwst.background.asn_intake - INFO - Working on input <ImageModel(2048, 2048) from jw02079004003_05101_00001_nis_rate.fits> ...
2025-09-13 16:39:25,601 - stpipe.Spec2Pipeline.bkg_subtract - INFO - Using BKG reference file /home/runner/crds/references/jwst/niriss/jwst_niriss_bkg_0027.fits
2025-09-13 16:39:25,602 - stpipe.Spec2Pipeline.bkg_subtract - INFO - Using WavelengthRange reference file /home/runner/crds/references/jwst/niriss/jwst_niriss_wavelengthrange_0002.asdf
2025-09-13 16:39:25,671 - jwst.assign_wcs.util - INFO - Getting objects from jw02079-o004_niriss_clear-f200w_cat.ecsv
2025-09-13 16:39:25,976 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1, order 1
2025-09-13 16:39:25,989 - jwst.assign_wcs.util - INFO - Excluding off-image object: 2, order 1
2025-09-13 16:39:26,001 - jwst.assign_wcs.util - INFO - Excluding off-image object: 3, order 1
2025-09-13 16:39:26,013 - jwst.assign_wcs.util - INFO - Excluding off-image object: 4, order 1
2025-09-13 16:39:26,026 - jwst.assign_wcs.util - INFO - Excluding off-image object: 5, order 1
2025-09-13 16:39:26,038 - jwst.assign_wcs.util - INFO - Excluding off-image object: 6, order 1
2025-09-13 16:39:26,051 - jwst.assign_wcs.util - INFO - Excluding off-image object: 7, order 1
2025-09-13 16:39:26,063 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 8 order: 1
2025-09-13 16:39:26,076 - jwst.assign_wcs.util - INFO - Excluding off-image object: 9, order 1
2025-09-13 16:39:26,088 - jwst.assign_wcs.util - INFO - Excluding off-image object: 10, order 1
2025-09-13 16:39:26,101 - jwst.assign_wcs.util - INFO - Excluding off-image object: 11, order 1
2025-09-13 16:39:26,113 - jwst.assign_wcs.util - INFO - Excluding off-image object: 12, order 1
2025-09-13 16:39:26,126 - jwst.assign_wcs.util - INFO - Excluding off-image object: 13, order 1
2025-09-13 16:39:26,139 - jwst.assign_wcs.util - INFO - Excluding off-image object: 14, order 1
2025-09-13 16:39:26,151 - jwst.assign_wcs.util - INFO - Excluding off-image object: 15, order 1
2025-09-13 16:39:26,163 - jwst.assign_wcs.util - INFO - Excluding off-image object: 16, order 1
2025-09-13 16:39:26,176 - jwst.assign_wcs.util - INFO - Excluding off-image object: 17, order 1
2025-09-13 16:39:26,188 - jwst.assign_wcs.util - INFO - Excluding off-image object: 18, order 1
2025-09-13 16:39:26,201 - jwst.assign_wcs.util - INFO - Excluding off-image object: 19, order 1
2025-09-13 16:39:26,213 - jwst.assign_wcs.util - INFO - Excluding off-image object: 20, order 1
2025-09-13 16:39:26,225 - jwst.assign_wcs.util - INFO - Excluding off-image object: 21, order 1
2025-09-13 16:39:26,238 - jwst.assign_wcs.util - INFO - Excluding off-image object: 22, order 1
2025-09-13 16:39:26,250 - jwst.assign_wcs.util - INFO - Excluding off-image object: 23, order 1
2025-09-13 16:39:26,262 - jwst.assign_wcs.util - INFO - Excluding off-image object: 24, order 1
2025-09-13 16:39:26,274 - jwst.assign_wcs.util - INFO - Excluding off-image object: 25, order 1
2025-09-13 16:39:26,287 - jwst.assign_wcs.util - INFO - Excluding off-image object: 26, order 1
2025-09-13 16:39:26,299 - jwst.assign_wcs.util - INFO - Excluding off-image object: 27, order 1
2025-09-13 16:39:26,312 - jwst.assign_wcs.util - INFO - Excluding off-image object: 28, order 1
2025-09-13 16:39:26,324 - jwst.assign_wcs.util - INFO - Excluding off-image object: 29, order 1
2025-09-13 16:39:26,336 - jwst.assign_wcs.util - INFO - Excluding off-image object: 30, order 1
2025-09-13 16:39:26,349 - jwst.assign_wcs.util - INFO - Excluding off-image object: 31, order 1
2025-09-13 16:39:26,361 - jwst.assign_wcs.util - INFO - Excluding off-image object: 32, order 1
2025-09-13 16:39:26,373 - jwst.assign_wcs.util - INFO - Excluding off-image object: 33, order 1
2025-09-13 16:39:26,386 - jwst.assign_wcs.util - INFO - Excluding off-image object: 34, order 1
2025-09-13 16:39:26,398 - jwst.assign_wcs.util - INFO - Excluding off-image object: 35, order 1
2025-09-13 16:39:26,410 - jwst.assign_wcs.util - INFO - Excluding off-image object: 36, order 1
2025-09-13 16:39:26,423 - jwst.assign_wcs.util - INFO - Excluding off-image object: 37, order 1
2025-09-13 16:39:26,435 - jwst.assign_wcs.util - INFO - Excluding off-image object: 38, order 1
2025-09-13 16:39:26,447 - jwst.assign_wcs.util - INFO - Excluding off-image object: 39, order 1
2025-09-13 16:39:26,459 - jwst.assign_wcs.util - INFO - Excluding off-image object: 40, order 1
2025-09-13 16:39:26,471 - jwst.assign_wcs.util - INFO - Excluding off-image object: 41, order 1
2025-09-13 16:39:26,484 - jwst.assign_wcs.util - INFO - Excluding off-image object: 42, order 1
2025-09-13 16:39:26,496 - jwst.assign_wcs.util - INFO - Excluding off-image object: 43, order 1
2025-09-13 16:39:26,508 - jwst.assign_wcs.util - INFO - Excluding off-image object: 44, order 1
2025-09-13 16:39:26,520 - jwst.assign_wcs.util - INFO - Excluding off-image object: 45, order 1
2025-09-13 16:39:26,533 - jwst.assign_wcs.util - INFO - Excluding off-image object: 46, order 1
2025-09-13 16:39:26,545 - jwst.assign_wcs.util - INFO - Excluding off-image object: 47, order 1
2025-09-13 16:39:26,557 - jwst.assign_wcs.util - INFO - Excluding off-image object: 48, order 1
2025-09-13 16:39:26,570 - jwst.assign_wcs.util - INFO - Excluding off-image object: 49, order 1
2025-09-13 16:39:26,582 - jwst.assign_wcs.util - INFO - Excluding off-image object: 50, order 1
2025-09-13 16:39:26,595 - jwst.assign_wcs.util - INFO - Excluding off-image object: 51, order 1
2025-09-13 16:39:26,607 - jwst.assign_wcs.util - INFO - Excluding off-image object: 52, order 1
2025-09-13 16:39:26,620 - jwst.assign_wcs.util - INFO - Excluding off-image object: 53, order 1
2025-09-13 16:39:26,632 - jwst.assign_wcs.util - INFO - Excluding off-image object: 54, order 1
2025-09-13 16:39:26,645 - jwst.assign_wcs.util - INFO - Excluding off-image object: 55, order 1
2025-09-13 16:39:26,657 - jwst.assign_wcs.util - INFO - Excluding off-image object: 56, order 1
2025-09-13 16:39:26,669 - jwst.assign_wcs.util - INFO - Excluding off-image object: 57, order 1
2025-09-13 16:39:26,682 - jwst.assign_wcs.util - INFO - Excluding off-image object: 58, order 1
2025-09-13 16:39:26,694 - jwst.assign_wcs.util - INFO - Excluding off-image object: 59, order 1
2025-09-13 16:39:26,706 - jwst.assign_wcs.util - INFO - Excluding off-image object: 60, order 1
2025-09-13 16:39:26,720 - jwst.assign_wcs.util - INFO - Excluding off-image object: 61, order 1
2025-09-13 16:39:26,732 - jwst.assign_wcs.util - INFO - Excluding off-image object: 62, order 1
2025-09-13 16:39:26,745 - jwst.assign_wcs.util - INFO - Excluding off-image object: 63, order 1
2025-09-13 16:39:26,757 - jwst.assign_wcs.util - INFO - Excluding off-image object: 64, order 1
2025-09-13 16:39:26,769 - jwst.assign_wcs.util - INFO - Excluding off-image object: 65, order 1
2025-09-13 16:39:26,781 - jwst.assign_wcs.util - INFO - Excluding off-image object: 66, order 1
2025-09-13 16:39:26,794 - jwst.assign_wcs.util - INFO - Excluding off-image object: 67, order 1
2025-09-13 16:39:26,806 - jwst.assign_wcs.util - INFO - Excluding off-image object: 68, order 1
2025-09-13 16:39:26,818 - jwst.assign_wcs.util - INFO - Excluding off-image object: 69, order 1
2025-09-13 16:39:26,830 - jwst.assign_wcs.util - INFO - Excluding off-image object: 70, order 1
2025-09-13 16:39:26,843 - jwst.assign_wcs.util - INFO - Excluding off-image object: 71, order 1
2025-09-13 16:39:26,855 - jwst.assign_wcs.util - INFO - Excluding off-image object: 72, order 1
2025-09-13 16:39:26,867 - jwst.assign_wcs.util - INFO - Excluding off-image object: 73, order 1
2025-09-13 16:39:26,879 - jwst.assign_wcs.util - INFO - Excluding off-image object: 74, order 1
2025-09-13 16:39:26,892 - jwst.assign_wcs.util - INFO - Excluding off-image object: 75, order 1
2025-09-13 16:39:26,904 - jwst.assign_wcs.util - INFO - Excluding off-image object: 76, order 1
2025-09-13 16:39:26,917 - jwst.assign_wcs.util - INFO - Excluding off-image object: 77, order 1
2025-09-13 16:39:26,929 - jwst.assign_wcs.util - INFO - Excluding off-image object: 78, order 1
2025-09-13 16:39:26,941 - jwst.assign_wcs.util - INFO - Excluding off-image object: 79, order 1
2025-09-13 16:39:26,953 - jwst.assign_wcs.util - INFO - Excluding off-image object: 80, order 1
2025-09-13 16:39:26,966 - jwst.assign_wcs.util - INFO - Excluding off-image object: 81, order 1
2025-09-13 16:39:26,978 - jwst.assign_wcs.util - INFO - Excluding off-image object: 82, order 1
2025-09-13 16:39:26,991 - jwst.assign_wcs.util - INFO - Excluding off-image object: 83, order 1
2025-09-13 16:39:27,003 - jwst.assign_wcs.util - INFO - Excluding off-image object: 84, order 1
2025-09-13 16:39:27,016 - jwst.assign_wcs.util - INFO - Excluding off-image object: 85, order 1
2025-09-13 16:39:27,028 - jwst.assign_wcs.util - INFO - Excluding off-image object: 86, order 1
2025-09-13 16:39:27,040 - jwst.assign_wcs.util - INFO - Excluding off-image object: 87, order 1
2025-09-13 16:39:27,054 - jwst.assign_wcs.util - INFO - Excluding off-image object: 88, order 1
2025-09-13 16:39:27,066 - jwst.assign_wcs.util - INFO - Excluding off-image object: 89, order 1
2025-09-13 16:39:27,079 - jwst.assign_wcs.util - INFO - Excluding off-image object: 90, order 1
2025-09-13 16:39:27,091 - jwst.assign_wcs.util - INFO - Excluding off-image object: 91, order 1
2025-09-13 16:39:27,104 - jwst.assign_wcs.util - INFO - Excluding off-image object: 92, order 1
2025-09-13 16:39:27,116 - jwst.assign_wcs.util - INFO - Excluding off-image object: 93, order 1
2025-09-13 16:39:27,129 - jwst.assign_wcs.util - INFO - Excluding off-image object: 94, order 1
2025-09-13 16:39:27,141 - jwst.assign_wcs.util - INFO - Excluding off-image object: 95, order 1
2025-09-13 16:39:27,153 - jwst.assign_wcs.util - INFO - Excluding off-image object: 96, order 1
2025-09-13 16:39:27,165 - jwst.assign_wcs.util - INFO - Excluding off-image object: 97, order 1
2025-09-13 16:39:27,178 - jwst.assign_wcs.util - INFO - Excluding off-image object: 98, order 1
2025-09-13 16:39:27,190 - jwst.assign_wcs.util - INFO - Excluding off-image object: 99, order 1
2025-09-13 16:39:27,203 - jwst.assign_wcs.util - INFO - Excluding off-image object: 100, order 1
2025-09-13 16:39:27,215 - jwst.assign_wcs.util - INFO - Excluding off-image object: 101, order 1
2025-09-13 16:39:27,228 - jwst.assign_wcs.util - INFO - Excluding off-image object: 102, order 1
2025-09-13 16:39:27,240 - jwst.assign_wcs.util - INFO - Excluding off-image object: 103, order 1
2025-09-13 16:39:27,253 - jwst.assign_wcs.util - INFO - Excluding off-image object: 104, order 1
2025-09-13 16:39:27,265 - jwst.assign_wcs.util - INFO - Excluding off-image object: 105, order 1
2025-09-13 16:39:27,277 - jwst.assign_wcs.util - INFO - Excluding off-image object: 106, order 1
2025-09-13 16:39:27,289 - jwst.assign_wcs.util - INFO - Excluding off-image object: 107, order 1
2025-09-13 16:39:27,302 - jwst.assign_wcs.util - INFO - Excluding off-image object: 108, order 1
2025-09-13 16:39:27,314 - jwst.assign_wcs.util - INFO - Excluding off-image object: 109, order 1
2025-09-13 16:39:27,326 - jwst.assign_wcs.util - INFO - Excluding off-image object: 110, order 1
2025-09-13 16:39:27,339 - jwst.assign_wcs.util - INFO - Excluding off-image object: 111, order 1
2025-09-13 16:39:27,351 - jwst.assign_wcs.util - INFO - Excluding off-image object: 112, order 1
2025-09-13 16:39:27,363 - jwst.assign_wcs.util - INFO - Excluding off-image object: 113, order 1
2025-09-13 16:39:27,375 - jwst.assign_wcs.util - INFO - Excluding off-image object: 114, order 1
2025-09-13 16:39:27,388 - jwst.assign_wcs.util - INFO - Excluding off-image object: 115, order 1
2025-09-13 16:39:27,400 - jwst.assign_wcs.util - INFO - Excluding off-image object: 116, order 1
2025-09-13 16:39:27,421 - jwst.assign_wcs.util - INFO - Excluding off-image object: 117, order 1
2025-09-13 16:39:27,433 - jwst.assign_wcs.util - INFO - Excluding off-image object: 118, order 1
2025-09-13 16:39:27,446 - jwst.assign_wcs.util - INFO - Excluding off-image object: 119, order 1
2025-09-13 16:39:27,458 - jwst.assign_wcs.util - INFO - Excluding off-image object: 120, order 1
2025-09-13 16:39:27,471 - jwst.assign_wcs.util - INFO - Excluding off-image object: 121, order 1
2025-09-13 16:39:27,483 - jwst.assign_wcs.util - INFO - Excluding off-image object: 122, order 1
2025-09-13 16:39:27,496 - jwst.assign_wcs.util - INFO - Excluding off-image object: 123, order 1
2025-09-13 16:39:27,508 - jwst.assign_wcs.util - INFO - Excluding off-image object: 124, order 1
2025-09-13 16:39:27,521 - jwst.assign_wcs.util - INFO - Excluding off-image object: 125, order 1
2025-09-13 16:39:27,533 - jwst.assign_wcs.util - INFO - Excluding off-image object: 126, order 1
2025-09-13 16:39:27,545 - jwst.assign_wcs.util - INFO - Excluding off-image object: 127, order 1
2025-09-13 16:39:27,558 - jwst.assign_wcs.util - INFO - Excluding off-image object: 128, order 1
2025-09-13 16:39:27,570 - jwst.assign_wcs.util - INFO - Excluding off-image object: 129, order 1
2025-09-13 16:39:27,582 - jwst.assign_wcs.util - INFO - Excluding off-image object: 130, order 1
2025-09-13 16:39:27,595 - jwst.assign_wcs.util - INFO - Excluding off-image object: 131, order 1
2025-09-13 16:39:27,608 - jwst.assign_wcs.util - INFO - Excluding off-image object: 132, order 1
2025-09-13 16:39:27,621 - jwst.assign_wcs.util - INFO - Excluding off-image object: 133, order 1
2025-09-13 16:39:27,633 - jwst.assign_wcs.util - INFO - Excluding off-image object: 134, order 1
2025-09-13 16:39:27,646 - jwst.assign_wcs.util - INFO - Excluding off-image object: 135, order 1
2025-09-13 16:39:27,659 - jwst.assign_wcs.util - INFO - Excluding off-image object: 136, order 1
2025-09-13 16:39:27,671 - jwst.assign_wcs.util - INFO - Excluding off-image object: 137, order 1
2025-09-13 16:39:27,683 - jwst.assign_wcs.util - INFO - Excluding off-image object: 138, order 1
2025-09-13 16:39:27,695 - jwst.assign_wcs.util - INFO - Excluding off-image object: 139, order 1
2025-09-13 16:39:27,708 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 140 order: 1
2025-09-13 16:39:27,720 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 141 order: 1
2025-09-13 16:39:27,733 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 142 order: 1
2025-09-13 16:39:27,745 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 143 order: 1
2025-09-13 16:39:27,769 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 145 order: 1
2025-09-13 16:39:27,840 - jwst.assign_wcs.util - INFO - Excluding off-image object: 151, order 1
2025-09-13 16:39:27,853 - jwst.assign_wcs.util - INFO - Excluding off-image object: 152, order 1
2025-09-13 16:39:27,866 - jwst.assign_wcs.util - INFO - Excluding off-image object: 153, order 1
2025-09-13 16:39:27,890 - jwst.assign_wcs.util - INFO - Excluding off-image object: 155, order 1
2025-09-13 16:39:28,153 - jwst.assign_wcs.util - INFO - Excluding off-image object: 177, order 1
2025-09-13 16:39:28,178 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 179 order: 1
2025-09-13 16:39:28,202 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 181 order: 1
2025-09-13 16:39:28,307 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 190 order: 1
2025-09-13 16:39:28,401 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 198 order: 1
2025-09-13 16:39:28,426 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 200 order: 1
2025-09-13 16:39:28,463 - jwst.assign_wcs.util - INFO - Excluding off-image object: 203, order 1
2025-09-13 16:39:28,499 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 206 order: 1
2025-09-13 16:39:28,512 - jwst.assign_wcs.util - INFO - Excluding off-image object: 207, order 1
2025-09-13 16:39:28,648 - jwst.assign_wcs.util - INFO - Excluding off-image object: 219, order 1
2025-09-13 16:39:28,708 - jwst.assign_wcs.util - INFO - Excluding off-image object: 224, order 1
2025-09-13 16:39:28,769 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 229 order: 1
2025-09-13 16:39:28,794 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 231 order: 1
2025-09-13 16:39:28,987 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 247 order: 1
2025-09-13 16:39:29,001 - jwst.assign_wcs.util - INFO - Excluding off-image object: 248, order 1
2025-09-13 16:39:29,014 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 249 order: 1
2025-09-13 16:39:29,365 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 278 order: 1
2025-09-13 16:39:29,425 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 283 order: 1
2025-09-13 16:39:29,584 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 296 order: 1
2025-09-13 16:39:29,680 - jwst.assign_wcs.util - INFO - Excluding off-image object: 304, order 1
2025-09-13 16:39:29,693 - jwst.assign_wcs.util - INFO - Excluding off-image object: 305, order 1
2025-09-13 16:39:29,706 - jwst.assign_wcs.util - INFO - Excluding off-image object: 306, order 1
2025-09-13 16:39:29,922 - jwst.assign_wcs.util - INFO - Excluding off-image object: 324, order 1
2025-09-13 16:39:29,984 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 329 order: 1
2025-09-13 16:39:29,997 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 330 order: 1
2025-09-13 16:39:30,326 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 357 order: 1
2025-09-13 16:39:30,339 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 358 order: 1
2025-09-13 16:39:30,375 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 361 order: 1
2025-09-13 16:39:30,423 - jwst.assign_wcs.util - INFO - Excluding off-image object: 365, order 1
2025-09-13 16:39:30,483 - jwst.assign_wcs.util - INFO - Excluding off-image object: 370, order 1
2025-09-13 16:39:30,496 - jwst.assign_wcs.util - INFO - Excluding off-image object: 371, order 1
2025-09-13 16:39:30,557 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 376 order: 1
2025-09-13 16:39:30,699 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 388 order: 1
2025-09-13 16:39:31,112 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 423 order: 1
2025-09-13 16:39:31,371 - jwst.assign_wcs.util - INFO - Excluding off-image object: 445, order 1
2025-09-13 16:39:31,418 - jwst.assign_wcs.util - INFO - Excluding off-image object: 449, order 1
2025-09-13 16:39:31,654 - jwst.assign_wcs.util - INFO - Excluding off-image object: 469, order 1
2025-09-13 16:39:31,844 - jwst.assign_wcs.util - INFO - Excluding off-image object: 485, order 1
2025-09-13 16:39:31,869 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 487 order: 1
2025-09-13 16:39:32,009 - jwst.assign_wcs.util - INFO - Excluding off-image object: 499, order 1
2025-09-13 16:39:32,837 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 569 order: 1
2025-09-13 16:39:32,995 - jwst.assign_wcs.util - INFO - Excluding off-image object: 582, order 1
2025-09-13 16:39:33,222 - jwst.assign_wcs.util - INFO - Excluding off-image object: 601, order 1
2025-09-13 16:39:33,317 - jwst.assign_wcs.util - INFO - Excluding off-image object: 609, order 1
2025-09-13 16:39:33,330 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 610 order: 1
2025-09-13 16:39:33,554 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 629 order: 1
2025-09-13 16:39:33,765 - jwst.assign_wcs.util - INFO - Excluding off-image object: 647, order 1
2025-09-13 16:39:33,921 - jwst.assign_wcs.util - INFO - Excluding off-image object: 660, order 1
2025-09-13 16:39:33,969 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 664 order: 1
2025-09-13 16:39:33,982 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 665 order: 1
2025-09-13 16:39:34,042 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 670 order: 1
2025-09-13 16:39:34,078 - jwst.assign_wcs.util - INFO - Excluding off-image object: 673, order 1
2025-09-13 16:39:34,257 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 688 order: 1
2025-09-13 16:39:34,316 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 693 order: 1
2025-09-13 16:39:34,353 - jwst.assign_wcs.util - INFO - Excluding off-image object: 696, order 1
2025-09-13 16:39:34,389 - jwst.assign_wcs.util - INFO - Excluding off-image object: 699, order 1
2025-09-13 16:39:34,589 - jwst.assign_wcs.util - INFO - Excluding off-image object: 716, order 1
2025-09-13 16:39:34,683 - jwst.assign_wcs.util - INFO - Excluding off-image object: 724, order 1
2025-09-13 16:39:34,754 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 730 order: 1
2025-09-13 16:39:34,826 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 736 order: 1
2025-09-13 16:39:34,850 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 738 order: 1
2025-09-13 16:39:34,898 - jwst.assign_wcs.util - INFO - Excluding off-image object: 742, order 1
2025-09-13 16:39:34,910 - jwst.assign_wcs.util - INFO - Excluding off-image object: 743, order 1
2025-09-13 16:39:34,992 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 750 order: 1
2025-09-13 16:39:35,076 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 757 order: 1
2025-09-13 16:39:35,112 - jwst.assign_wcs.util - INFO - Excluding off-image object: 760, order 1
2025-09-13 16:39:35,239 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 771 order: 1
2025-09-13 16:39:35,346 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 780 order: 1
2025-09-13 16:39:35,617 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 803 order: 1
2025-09-13 16:39:35,698 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 810 order: 1
2025-09-13 16:39:35,783 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 817 order: 1
2025-09-13 16:39:35,831 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 821 order: 1
2025-09-13 16:39:35,939 - jwst.assign_wcs.util - INFO - Excluding off-image object: 830, order 1
2025-09-13 16:39:35,981 - jwst.assign_wcs.util - INFO - Excluding off-image object: 833, order 1
2025-09-13 16:39:36,115 - jwst.assign_wcs.util - INFO - Excluding off-image object: 844, order 1
2025-09-13 16:39:36,222 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 853 order: 1
2025-09-13 16:39:36,235 - jwst.assign_wcs.util - INFO - Excluding off-image object: 854, order 1
2025-09-13 16:39:36,523 - jwst.assign_wcs.util - INFO - Excluding off-image object: 878, order 1
2025-09-13 16:39:36,716 - jwst.assign_wcs.util - INFO - Excluding off-image object: 894, order 1
2025-09-13 16:39:36,813 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 902 order: 1
2025-09-13 16:39:36,909 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 910 order: 1
2025-09-13 16:39:36,994 - jwst.assign_wcs.util - INFO - Excluding off-image object: 917, order 1
2025-09-13 16:39:37,031 - jwst.assign_wcs.util - INFO - Excluding off-image object: 920, order 1
2025-09-13 16:39:37,104 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 926 order: 1
2025-09-13 16:39:37,380 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 949 order: 1
2025-09-13 16:39:37,441 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 954 order: 1
2025-09-13 16:39:37,513 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 960 order: 1
2025-09-13 16:39:37,739 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 979 order: 1
2025-09-13 16:39:37,822 - jwst.assign_wcs.util - INFO - Excluding off-image object: 986, order 1
2025-09-13 16:39:37,917 - jwst.assign_wcs.util - INFO - Excluding off-image object: 994, order 1
2025-09-13 16:39:38,000 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1001, order 1
2025-09-13 16:39:38,012 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1002 order: 1
2025-09-13 16:39:38,108 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1010 order: 1
2025-09-13 16:39:38,120 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1011 order: 1
2025-09-13 16:39:38,168 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1015, order 1
2025-09-13 16:39:38,205 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1018, order 1
2025-09-13 16:39:38,229 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1020 order: 1
2025-09-13 16:39:38,334 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1029 order: 1
2025-09-13 16:39:38,394 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1034, order 1
2025-09-13 16:39:38,571 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1049 order: 1
2025-09-13 16:39:38,596 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1051 order: 1
2025-09-13 16:39:38,620 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1053 order: 1
2025-09-13 16:39:39,051 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1089 order: 1
2025-09-13 16:39:39,101 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1093, order 1
2025-09-13 16:39:39,149 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1097, order 1
2025-09-13 16:39:39,220 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1103, order 1
2025-09-13 16:39:39,304 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1110, order 1
2025-09-13 16:39:39,482 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1125 order: 1
2025-09-13 16:39:39,684 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1142 order: 1
2025-09-13 16:39:39,744 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1147 order: 1
2025-09-13 16:39:39,827 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1154, order 1
2025-09-13 16:39:39,864 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1157, order 1
2025-09-13 16:39:39,901 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1160 order: 1
2025-09-13 16:39:40,008 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1169, order 1
2025-09-13 16:39:40,057 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1173, order 1
2025-09-13 16:39:40,129 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1179, order 1
2025-09-13 16:39:40,329 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1196 order: 1
2025-09-13 16:39:40,400 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1202, order 1
2025-09-13 16:39:40,412 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1203 order: 1
2025-09-13 16:39:40,437 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1205, order 1
2025-09-13 16:39:40,508 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1211, order 1
2025-09-13 16:39:40,618 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1220 order: 1
2025-09-13 16:39:40,653 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1223, order 1
2025-09-13 16:39:40,713 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1228, order 1
2025-09-13 16:39:40,761 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1232 order: 1
2025-09-13 16:39:40,773 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1233, order 1
2025-09-13 16:39:40,881 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1242 order: 1
2025-09-13 16:39:41,151 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1265 order: 1
2025-09-13 16:39:41,403 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1286, order 1
2025-09-13 16:39:41,462 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1291 order: 1
2025-09-13 16:39:41,499 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1294 order: 1
2025-09-13 16:39:41,535 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1297 order: 1
2025-09-13 16:39:41,642 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1306 order: 1
2025-09-13 16:39:41,813 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1320, order 1
2025-09-13 16:39:41,849 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1323, order 1
2025-09-13 16:39:42,295 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1361 order: 1
2025-09-13 16:39:42,447 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1374 order: 1
2025-09-13 16:39:42,507 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1379, order 1
2025-09-13 16:39:42,578 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1385 order: 1
2025-09-13 16:39:42,660 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1392 order: 1
2025-09-13 16:39:42,777 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1402 order: 1
2025-09-13 16:39:43,036 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1424 order: 1
2025-09-13 16:39:43,049 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1425, order 1
2025-09-13 16:39:43,241 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1441, order 1
2025-09-13 16:39:43,289 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1445 order: 1
2025-09-13 16:39:43,338 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1449 order: 1
2025-09-13 16:39:43,473 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1460 order: 1
2025-09-13 16:39:43,666 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1476 order: 1
2025-09-13 16:39:43,703 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1479 order: 1
2025-09-13 16:39:43,716 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1480 order: 1
2025-09-13 16:39:43,802 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1487, order 1
2025-09-13 16:39:43,851 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1491 order: 1
2025-09-13 16:39:43,875 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1493, order 1
2025-09-13 16:39:43,888 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1494, order 1
2025-09-13 16:39:43,901 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1495, order 1
2025-09-13 16:39:43,914 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1496, order 1
2025-09-13 16:39:43,927 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1497, order 1
2025-09-13 16:39:43,940 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1498, order 1
2025-09-13 16:39:43,953 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1499, order 1
2025-09-13 16:39:43,966 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1500, order 1
2025-09-13 16:39:43,978 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1501, order 1
2025-09-13 16:39:43,991 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1502, order 1
2025-09-13 16:39:43,991 - jwst.assign_wcs.util - INFO - Total of 1283 grism objects defined
2025-09-13 16:39:44,030 - jwst.background.background_sub_wfss - INFO - Starting iterative outlier rejection for background subtraction.
2025-09-13 16:39:44,574 - jwst.background.background_sub_wfss - INFO - Stopped at maxiter (5).
2025-09-13 16:39:44,749 - jwst.background.background_sub_wfss - INFO - Average of scaled background image = 4.451e-01
2025-09-13 16:39:44,750 - jwst.background.background_sub_wfss - INFO - Scaling factor = 4.59603e-01
2025-09-13 16:39:44,757 - stpipe.Spec2Pipeline.bkg_subtract - INFO - Step bkg_subtract done
2025-09-13 16:39:45,147 - stpipe.Spec2Pipeline.flat_field - INFO - Step flat_field running with args (<ImageModel(2048, 2048) from jw02079004003_05101_00001_nis_rate.fits>,).
2025-09-13 16:39:45,223 - stpipe.Spec2Pipeline.flat_field - INFO - Using FLAT reference file: /home/runner/crds/references/jwst/niriss/jwst_niriss_flat_0265.fits
2025-09-13 16:39:45,223 - stpipe.Spec2Pipeline.flat_field - INFO - No reference found for type FFLAT
2025-09-13 16:39:45,223 - stpipe.Spec2Pipeline.flat_field - INFO - No reference found for type SFLAT
2025-09-13 16:39:45,224 - stpipe.Spec2Pipeline.flat_field - INFO - No reference found for type DFLAT
2025-09-13 16:39:45,442 - stpipe.Spec2Pipeline.flat_field - INFO - Step flat_field done
2025-09-13 16:39:45,810 - stpipe.Spec2Pipeline.extract_2d - INFO - Step extract_2d running with args (<ImageModel(2048, 2048) from jw02079004003_05101_00001_nis_rate.fits>,).
2025-09-13 16:39:45,821 - jwst.extract_2d.extract_2d - INFO - EXP_TYPE is NIS_WFSS
2025-09-13 16:39:45,832 - jwst.assign_wcs.util - INFO - Getting objects from jw02079-o004_niriss_clear-f200w_cat.ecsv
2025-09-13 16:39:46,135 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1, order 1
2025-09-13 16:39:46,147 - jwst.assign_wcs.util - INFO - Excluding off-image object: 2, order 1
2025-09-13 16:39:46,156 - jwst.assign_wcs.util - INFO - Excluding off-image object: 3, order 1
2025-09-13 16:39:46,168 - jwst.assign_wcs.util - INFO - Excluding off-image object: 4, order 1
2025-09-13 16:39:46,180 - jwst.assign_wcs.util - INFO - Excluding off-image object: 5, order 1
2025-09-13 16:39:46,192 - jwst.assign_wcs.util - INFO - Excluding off-image object: 6, order 1
2025-09-13 16:39:46,204 - jwst.assign_wcs.util - INFO - Excluding off-image object: 7, order 1
2025-09-13 16:39:46,215 - jwst.assign_wcs.util - INFO - Excluding off-image object: 8, order 1
2025-09-13 16:39:46,227 - jwst.assign_wcs.util - INFO - Excluding off-image object: 9, order 1
2025-09-13 16:39:46,239 - jwst.assign_wcs.util - INFO - Excluding off-image object: 10, order 1
2025-09-13 16:39:46,251 - jwst.assign_wcs.util - INFO - Excluding off-image object: 11, order 1
2025-09-13 16:39:46,263 - jwst.assign_wcs.util - INFO - Excluding off-image object: 12, order 1
2025-09-13 16:39:46,275 - jwst.assign_wcs.util - INFO - Excluding off-image object: 13, order 1
2025-09-13 16:39:46,286 - jwst.assign_wcs.util - INFO - Excluding off-image object: 14, order 1
2025-09-13 16:39:46,298 - jwst.assign_wcs.util - INFO - Excluding off-image object: 15, order 1
2025-09-13 16:39:46,310 - jwst.assign_wcs.util - INFO - Excluding off-image object: 16, order 1
2025-09-13 16:39:46,322 - jwst.assign_wcs.util - INFO - Excluding off-image object: 17, order 1
2025-09-13 16:39:46,334 - jwst.assign_wcs.util - INFO - Excluding off-image object: 18, order 1
2025-09-13 16:39:46,345 - jwst.assign_wcs.util - INFO - Excluding off-image object: 19, order 1
2025-09-13 16:39:46,357 - jwst.assign_wcs.util - INFO - Excluding off-image object: 20, order 1
2025-09-13 16:39:46,369 - jwst.assign_wcs.util - INFO - Excluding off-image object: 21, order 1
2025-09-13 16:39:46,380 - jwst.assign_wcs.util - INFO - Excluding off-image object: 22, order 1
2025-09-13 16:39:46,392 - jwst.assign_wcs.util - INFO - Excluding off-image object: 23, order 1
2025-09-13 16:39:46,404 - jwst.assign_wcs.util - INFO - Excluding off-image object: 24, order 1
2025-09-13 16:39:46,416 - jwst.assign_wcs.util - INFO - Excluding off-image object: 25, order 1
2025-09-13 16:39:46,425 - jwst.assign_wcs.util - INFO - Excluding off-image object: 26, order 1
2025-09-13 16:39:46,437 - jwst.assign_wcs.util - INFO - Excluding off-image object: 27, order 1
2025-09-13 16:39:46,449 - jwst.assign_wcs.util - INFO - Excluding off-image object: 28, order 1
2025-09-13 16:39:46,460 - jwst.assign_wcs.util - INFO - Excluding off-image object: 29, order 1
2025-09-13 16:39:46,472 - jwst.assign_wcs.util - INFO - Excluding off-image object: 30, order 1
2025-09-13 16:39:46,481 - jwst.assign_wcs.util - INFO - Excluding off-image object: 31, order 1
2025-09-13 16:39:46,493 - jwst.assign_wcs.util - INFO - Excluding off-image object: 32, order 1
2025-09-13 16:39:46,502 - jwst.assign_wcs.util - INFO - Excluding off-image object: 33, order 1
2025-09-13 16:39:46,513 - jwst.assign_wcs.util - INFO - Excluding off-image object: 34, order 1
2025-09-13 16:39:46,525 - jwst.assign_wcs.util - INFO - Excluding off-image object: 35, order 1
2025-09-13 16:39:46,534 - jwst.assign_wcs.util - INFO - Excluding off-image object: 36, order 1
2025-09-13 16:39:46,547 - jwst.assign_wcs.util - INFO - Excluding off-image object: 37, order 1
2025-09-13 16:39:46,556 - jwst.assign_wcs.util - INFO - Excluding off-image object: 38, order 1
2025-09-13 16:39:46,568 - jwst.assign_wcs.util - INFO - Excluding off-image object: 39, order 1
2025-09-13 16:39:46,580 - jwst.assign_wcs.util - INFO - Excluding off-image object: 40, order 1
2025-09-13 16:39:46,591 - jwst.assign_wcs.util - INFO - Excluding off-image object: 41, order 1
2025-09-13 16:39:46,600 - jwst.assign_wcs.util - INFO - Excluding off-image object: 42, order 1
2025-09-13 16:39:46,609 - jwst.assign_wcs.util - INFO - Excluding off-image object: 43, order 1
2025-09-13 16:39:46,621 - jwst.assign_wcs.util - INFO - Excluding off-image object: 44, order 1
2025-09-13 16:39:46,633 - jwst.assign_wcs.util - INFO - Excluding off-image object: 45, order 1
2025-09-13 16:39:46,642 - jwst.assign_wcs.util - INFO - Excluding off-image object: 46, order 1
2025-09-13 16:39:46,653 - jwst.assign_wcs.util - INFO - Excluding off-image object: 47, order 1
2025-09-13 16:39:46,662 - jwst.assign_wcs.util - INFO - Excluding off-image object: 48, order 1
2025-09-13 16:39:46,674 - jwst.assign_wcs.util - INFO - Excluding off-image object: 49, order 1
2025-09-13 16:39:46,685 - jwst.assign_wcs.util - INFO - Excluding off-image object: 50, order 1
2025-09-13 16:39:46,694 - jwst.assign_wcs.util - INFO - Excluding off-image object: 51, order 1
2025-09-13 16:39:46,703 - jwst.assign_wcs.util - INFO - Excluding off-image object: 52, order 1
2025-09-13 16:39:46,712 - jwst.assign_wcs.util - INFO - Excluding off-image object: 53, order 1
2025-09-13 16:39:46,724 - jwst.assign_wcs.util - INFO - Excluding off-image object: 54, order 1
2025-09-13 16:39:46,732 - jwst.assign_wcs.util - INFO - Excluding off-image object: 55, order 1
2025-09-13 16:39:46,741 - jwst.assign_wcs.util - INFO - Excluding off-image object: 56, order 1
2025-09-13 16:39:46,753 - jwst.assign_wcs.util - INFO - Excluding off-image object: 57, order 1
2025-09-13 16:39:46,765 - jwst.assign_wcs.util - INFO - Excluding off-image object: 58, order 1
2025-09-13 16:39:46,774 - jwst.assign_wcs.util - INFO - Excluding off-image object: 59, order 1
2025-09-13 16:39:46,783 - jwst.assign_wcs.util - INFO - Excluding off-image object: 60, order 1
2025-09-13 16:39:46,792 - jwst.assign_wcs.util - INFO - Excluding off-image object: 61, order 1
2025-09-13 16:39:46,801 - jwst.assign_wcs.util - INFO - Excluding off-image object: 62, order 1
2025-09-13 16:39:46,813 - jwst.assign_wcs.util - INFO - Excluding off-image object: 63, order 1
2025-09-13 16:39:46,824 - jwst.assign_wcs.util - INFO - Excluding off-image object: 64, order 1
2025-09-13 16:39:46,833 - jwst.assign_wcs.util - INFO - Excluding off-image object: 65, order 1
2025-09-13 16:39:46,845 - jwst.assign_wcs.util - INFO - Excluding off-image object: 66, order 1
2025-09-13 16:39:46,854 - jwst.assign_wcs.util - INFO - Excluding off-image object: 67, order 1
2025-09-13 16:39:46,863 - jwst.assign_wcs.util - INFO - Excluding off-image object: 68, order 1
2025-09-13 16:39:46,875 - jwst.assign_wcs.util - INFO - Excluding off-image object: 69, order 1
2025-09-13 16:39:46,887 - jwst.assign_wcs.util - INFO - Excluding off-image object: 70, order 1
2025-09-13 16:39:46,899 - jwst.assign_wcs.util - INFO - Excluding off-image object: 71, order 1
2025-09-13 16:39:46,908 - jwst.assign_wcs.util - INFO - Excluding off-image object: 72, order 1
2025-09-13 16:39:46,917 - jwst.assign_wcs.util - INFO - Excluding off-image object: 73, order 1
2025-09-13 16:39:46,926 - jwst.assign_wcs.util - INFO - Excluding off-image object: 74, order 1
2025-09-13 16:39:46,935 - jwst.assign_wcs.util - INFO - Excluding off-image object: 75, order 1
2025-09-13 16:39:46,944 - jwst.assign_wcs.util - INFO - Excluding off-image object: 76, order 1
2025-09-13 16:39:46,955 - jwst.assign_wcs.util - INFO - Excluding off-image object: 77, order 1
2025-09-13 16:39:46,967 - jwst.assign_wcs.util - INFO - Excluding off-image object: 78, order 1
2025-09-13 16:39:46,976 - jwst.assign_wcs.util - INFO - Excluding off-image object: 79, order 1
2025-09-13 16:39:46,988 - jwst.assign_wcs.util - INFO - Excluding off-image object: 80, order 1
2025-09-13 16:39:46,997 - jwst.assign_wcs.util - INFO - Excluding off-image object: 81, order 1
2025-09-13 16:39:47,006 - jwst.assign_wcs.util - INFO - Excluding off-image object: 82, order 1
2025-09-13 16:39:47,018 - jwst.assign_wcs.util - INFO - Excluding off-image object: 83, order 1
2025-09-13 16:39:47,027 - jwst.assign_wcs.util - INFO - Excluding off-image object: 84, order 1
2025-09-13 16:39:47,036 - jwst.assign_wcs.util - INFO - Excluding off-image object: 85, order 1
2025-09-13 16:39:47,045 - jwst.assign_wcs.util - INFO - Excluding off-image object: 86, order 1
2025-09-13 16:39:47,059 - jwst.assign_wcs.util - INFO - Excluding off-image object: 87, order 1
2025-09-13 16:39:47,068 - jwst.assign_wcs.util - INFO - Excluding off-image object: 88, order 1
2025-09-13 16:39:47,077 - jwst.assign_wcs.util - INFO - Excluding off-image object: 89, order 1
2025-09-13 16:39:47,089 - jwst.assign_wcs.util - INFO - Excluding off-image object: 90, order 1
2025-09-13 16:39:47,099 - jwst.assign_wcs.util - INFO - Excluding off-image object: 91, order 1
2025-09-13 16:39:47,111 - jwst.assign_wcs.util - INFO - Excluding off-image object: 92, order 1
2025-09-13 16:39:47,120 - jwst.assign_wcs.util - INFO - Excluding off-image object: 93, order 1
2025-09-13 16:39:47,129 - jwst.assign_wcs.util - INFO - Excluding off-image object: 94, order 1
2025-09-13 16:39:47,138 - jwst.assign_wcs.util - INFO - Excluding off-image object: 95, order 1
2025-09-13 16:39:47,150 - jwst.assign_wcs.util - INFO - Excluding off-image object: 96, order 1
2025-09-13 16:39:47,163 - jwst.assign_wcs.util - INFO - Excluding off-image object: 97, order 1
2025-09-13 16:39:47,172 - jwst.assign_wcs.util - INFO - Excluding off-image object: 98, order 1
2025-09-13 16:39:47,182 - jwst.assign_wcs.util - INFO - Excluding off-image object: 99, order 1
2025-09-13 16:39:47,191 - jwst.assign_wcs.util - INFO - Excluding off-image object: 100, order 1
2025-09-13 16:39:47,200 - jwst.assign_wcs.util - INFO - Excluding off-image object: 101, order 1
2025-09-13 16:39:47,209 - jwst.assign_wcs.util - INFO - Excluding off-image object: 102, order 1
2025-09-13 16:39:47,218 - jwst.assign_wcs.util - INFO - Excluding off-image object: 103, order 1
2025-09-13 16:39:47,228 - jwst.assign_wcs.util - INFO - Excluding off-image object: 104, order 1
2025-09-13 16:39:47,240 - jwst.assign_wcs.util - INFO - Excluding off-image object: 105, order 1
2025-09-13 16:39:47,249 - jwst.assign_wcs.util - INFO - Excluding off-image object: 106, order 1
2025-09-13 16:39:47,258 - jwst.assign_wcs.util - INFO - Excluding off-image object: 107, order 1
2025-09-13 16:39:47,270 - jwst.assign_wcs.util - INFO - Excluding off-image object: 108, order 1
2025-09-13 16:39:47,279 - jwst.assign_wcs.util - INFO - Excluding off-image object: 109, order 1
2025-09-13 16:39:47,291 - jwst.assign_wcs.util - INFO - Excluding off-image object: 110, order 1
2025-09-13 16:39:47,300 - jwst.assign_wcs.util - INFO - Excluding off-image object: 111, order 1
2025-09-13 16:39:47,309 - jwst.assign_wcs.util - INFO - Excluding off-image object: 112, order 1
2025-09-13 16:39:47,317 - jwst.assign_wcs.util - INFO - Excluding off-image object: 113, order 1
2025-09-13 16:39:47,326 - jwst.assign_wcs.util - INFO - Excluding off-image object: 114, order 1
2025-09-13 16:39:47,335 - jwst.assign_wcs.util - INFO - Excluding off-image object: 115, order 1
2025-09-13 16:39:47,344 - jwst.assign_wcs.util - INFO - Excluding off-image object: 116, order 1
2025-09-13 16:39:47,353 - jwst.assign_wcs.util - INFO - Excluding off-image object: 117, order 1
2025-09-13 16:39:47,362 - jwst.assign_wcs.util - INFO - Excluding off-image object: 118, order 1
2025-09-13 16:39:47,371 - jwst.assign_wcs.util - INFO - Excluding off-image object: 119, order 1
2025-09-13 16:39:47,383 - jwst.assign_wcs.util - INFO - Excluding off-image object: 120, order 1
2025-09-13 16:39:47,392 - jwst.assign_wcs.util - INFO - Excluding off-image object: 121, order 1
2025-09-13 16:39:47,404 - jwst.assign_wcs.util - INFO - Excluding off-image object: 122, order 1
2025-09-13 16:39:47,413 - jwst.assign_wcs.util - INFO - Excluding off-image object: 123, order 1
2025-09-13 16:39:47,422 - jwst.assign_wcs.util - INFO - Excluding off-image object: 124, order 1
2025-09-13 16:39:47,431 - jwst.assign_wcs.util - INFO - Excluding off-image object: 125, order 1
2025-09-13 16:39:47,440 - jwst.assign_wcs.util - INFO - Excluding off-image object: 126, order 1
2025-09-13 16:39:47,449 - jwst.assign_wcs.util - INFO - Excluding off-image object: 127, order 1
2025-09-13 16:39:47,458 - jwst.assign_wcs.util - INFO - Excluding off-image object: 128, order 1
2025-09-13 16:39:47,470 - jwst.assign_wcs.util - INFO - Excluding off-image object: 129, order 1
2025-09-13 16:39:47,479 - jwst.assign_wcs.util - INFO - Excluding off-image object: 130, order 1
2025-09-13 16:39:47,488 - jwst.assign_wcs.util - INFO - Excluding off-image object: 131, order 1
2025-09-13 16:39:47,497 - jwst.assign_wcs.util - INFO - Excluding off-image object: 132, order 1
2025-09-13 16:39:47,505 - jwst.assign_wcs.util - INFO - Excluding off-image object: 133, order 1
2025-09-13 16:39:47,514 - jwst.assign_wcs.util - INFO - Excluding off-image object: 134, order 1
2025-09-13 16:39:47,523 - jwst.assign_wcs.util - INFO - Excluding off-image object: 135, order 1
2025-09-13 16:39:47,534 - jwst.assign_wcs.util - INFO - Excluding off-image object: 136, order 1
2025-09-13 16:39:47,546 - jwst.assign_wcs.util - INFO - Excluding off-image object: 137, order 1
2025-09-13 16:39:47,558 - jwst.assign_wcs.util - INFO - Excluding off-image object: 138, order 1
2025-09-13 16:39:47,572 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 139 order: 1
2025-09-13 16:39:47,581 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 140 order: 1
2025-09-13 16:39:47,590 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 141 order: 1
2025-09-13 16:39:47,602 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 142 order: 1
2025-09-13 16:39:47,611 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 143 order: 1
2025-09-13 16:39:47,622 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 144 order: 1
2025-09-13 16:39:47,634 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 145 order: 1
2025-09-13 16:39:47,688 - jwst.assign_wcs.util - INFO - Excluding off-image object: 151, order 1
2025-09-13 16:39:47,700 - jwst.assign_wcs.util - INFO - Excluding off-image object: 152, order 1
2025-09-13 16:39:47,712 - jwst.assign_wcs.util - INFO - Excluding off-image object: 153, order 1
2025-09-13 16:39:47,733 - jwst.assign_wcs.util - INFO - Excluding off-image object: 155, order 1
2025-09-13 16:39:47,931 - jwst.assign_wcs.util - INFO - Excluding off-image object: 177, order 1
2025-09-13 16:39:47,948 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 179 order: 1
2025-09-13 16:39:47,969 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 181 order: 1
2025-09-13 16:39:48,056 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 190 order: 1
2025-09-13 16:39:48,124 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 198 order: 1
2025-09-13 16:39:48,144 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 200 order: 1
2025-09-13 16:39:48,169 - jwst.assign_wcs.util - INFO - Excluding off-image object: 203, order 1
2025-09-13 16:39:48,196 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 206 order: 1
2025-09-13 16:39:48,205 - jwst.assign_wcs.util - INFO - Excluding off-image object: 207, order 1
2025-09-13 16:39:48,314 - jwst.assign_wcs.util - INFO - Excluding off-image object: 219, order 1
2025-09-13 16:39:48,366 - jwst.assign_wcs.util - INFO - Excluding off-image object: 224, order 1
2025-09-13 16:39:48,412 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 229 order: 1
2025-09-13 16:39:48,432 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 231 order: 1
2025-09-13 16:39:48,577 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 247 order: 1
2025-09-13 16:39:48,586 - jwst.assign_wcs.util - INFO - Excluding off-image object: 248, order 1
2025-09-13 16:39:48,595 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 249 order: 1
2025-09-13 16:39:48,862 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 278 order: 1
2025-09-13 16:39:48,911 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 283 order: 1
2025-09-13 16:39:49,030 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 296 order: 1
2025-09-13 16:39:49,104 - jwst.assign_wcs.util - INFO - Excluding off-image object: 304, order 1
2025-09-13 16:39:49,116 - jwst.assign_wcs.util - INFO - Excluding off-image object: 305, order 1
2025-09-13 16:39:49,128 - jwst.assign_wcs.util - INFO - Excluding off-image object: 306, order 1
2025-09-13 16:39:49,289 - jwst.assign_wcs.util - INFO - Excluding off-image object: 324, order 1
2025-09-13 16:39:49,338 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 329 order: 1
2025-09-13 16:39:49,347 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 330 order: 1
2025-09-13 16:39:49,597 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 357 order: 1
2025-09-13 16:39:49,610 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 358 order: 1
2025-09-13 16:39:49,636 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 361 order: 1
2025-09-13 16:39:49,674 - jwst.assign_wcs.util - INFO - Excluding off-image object: 365, order 1
2025-09-13 16:39:49,726 - jwst.assign_wcs.util - INFO - Excluding off-image object: 370, order 1
2025-09-13 16:39:49,738 - jwst.assign_wcs.util - INFO - Excluding off-image object: 371, order 1
2025-09-13 16:39:49,782 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 376 order: 1
2025-09-13 16:39:49,897 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 388 order: 1
2025-09-13 16:39:50,232 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 423 order: 1
2025-09-13 16:39:50,444 - jwst.assign_wcs.util - INFO - Excluding off-image object: 445, order 1
2025-09-13 16:39:50,479 - jwst.assign_wcs.util - INFO - Excluding off-image object: 449, order 1
2025-09-13 16:39:50,669 - jwst.assign_wcs.util - INFO - Excluding off-image object: 469, order 1
2025-09-13 16:39:50,816 - jwst.assign_wcs.util - INFO - Excluding off-image object: 485, order 1
2025-09-13 16:39:50,837 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 487 order: 1
2025-09-13 16:39:50,946 - jwst.assign_wcs.util - INFO - Excluding off-image object: 499, order 1
2025-09-13 16:39:51,592 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 569 order: 1
2025-09-13 16:39:51,712 - jwst.assign_wcs.util - INFO - Excluding off-image object: 582, order 1
2025-09-13 16:39:51,896 - jwst.assign_wcs.util - INFO - Excluding off-image object: 601, order 1
2025-09-13 16:39:51,971 - jwst.assign_wcs.util - INFO - Excluding off-image object: 609, order 1
2025-09-13 16:39:51,983 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 610 order: 1
2025-09-13 16:39:52,163 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 629 order: 1
2025-09-13 16:39:52,327 - jwst.assign_wcs.util - INFO - Excluding off-image object: 647, order 1
2025-09-13 16:39:52,453 - jwst.assign_wcs.util - INFO - Excluding off-image object: 660, order 1
2025-09-13 16:39:52,490 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 664 order: 1
2025-09-13 16:39:52,502 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 665 order: 1
2025-09-13 16:39:52,554 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 670 order: 1
2025-09-13 16:39:52,580 - jwst.assign_wcs.util - INFO - Excluding off-image object: 673, order 1
2025-09-13 16:39:52,714 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 688 order: 1
2025-09-13 16:39:52,758 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 693 order: 1
2025-09-13 16:39:52,784 - jwst.assign_wcs.util - INFO - Excluding off-image object: 696, order 1
2025-09-13 16:39:52,813 - jwst.assign_wcs.util - INFO - Excluding off-image object: 699, order 1
2025-09-13 16:39:52,967 - jwst.assign_wcs.util - INFO - Excluding off-image object: 716, order 1
2025-09-13 16:39:53,037 - jwst.assign_wcs.util - INFO - Excluding off-image object: 724, order 1
2025-09-13 16:39:53,092 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 730 order: 1
2025-09-13 16:39:53,143 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 736 order: 1
2025-09-13 16:39:53,164 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 738 order: 1
2025-09-13 16:39:53,198 - jwst.assign_wcs.util - INFO - Excluding off-image object: 742, order 1
2025-09-13 16:39:53,207 - jwst.assign_wcs.util - INFO - Excluding off-image object: 743, order 1
2025-09-13 16:39:53,269 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 750 order: 1
2025-09-13 16:39:53,331 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 757 order: 1
2025-09-13 16:39:53,360 - jwst.assign_wcs.util - INFO - Excluding off-image object: 760, order 1
2025-09-13 16:39:53,464 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 771 order: 1
2025-09-13 16:39:53,543 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 780 order: 1
2025-09-13 16:39:53,746 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 803 order: 1
2025-09-13 16:39:53,814 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 810 order: 1
2025-09-13 16:39:53,879 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 817 order: 1
2025-09-13 16:39:53,916 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 821 order: 1
2025-09-13 16:39:54,001 - jwst.assign_wcs.util - INFO - Excluding off-image object: 830, order 1
2025-09-13 16:39:54,030 - jwst.assign_wcs.util - INFO - Excluding off-image object: 833, order 1
2025-09-13 16:39:54,128 - jwst.assign_wcs.util - INFO - Excluding off-image object: 844, order 1
2025-09-13 16:39:54,210 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 853 order: 1
2025-09-13 16:39:54,219 - jwst.assign_wcs.util - INFO - Excluding off-image object: 854, order 1
2025-09-13 16:39:54,446 - jwst.assign_wcs.util - INFO - Excluding off-image object: 878, order 1
2025-09-13 16:39:54,595 - jwst.assign_wcs.util - INFO - Excluding off-image object: 894, order 1
2025-09-13 16:39:54,669 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 902 order: 1
2025-09-13 16:39:54,741 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 910 order: 1
2025-09-13 16:39:54,803 - jwst.assign_wcs.util - INFO - Excluding off-image object: 917, order 1
2025-09-13 16:39:54,829 - jwst.assign_wcs.util - INFO - Excluding off-image object: 920, order 1
2025-09-13 16:39:54,880 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 926 order: 1
2025-09-13 16:39:55,086 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 949 order: 1
2025-09-13 16:39:55,135 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 954 order: 1
2025-09-13 16:39:55,192 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 960 order: 1
2025-09-13 16:39:55,361 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 979 order: 1
2025-09-13 16:39:55,420 - jwst.assign_wcs.util - INFO - Excluding off-image object: 986, order 1
2025-09-13 16:39:55,492 - jwst.assign_wcs.util - INFO - Excluding off-image object: 994, order 1
2025-09-13 16:39:55,554 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1001, order 1
2025-09-13 16:39:55,563 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1002 order: 1
2025-09-13 16:39:55,634 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1010 order: 1
2025-09-13 16:39:55,646 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1011 order: 1
2025-09-13 16:39:55,683 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1015, order 1
2025-09-13 16:39:55,712 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1018, order 1
2025-09-13 16:39:55,730 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1020 order: 1
2025-09-13 16:39:55,816 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1029 order: 1
2025-09-13 16:39:55,864 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1034, order 1
2025-09-13 16:39:56,002 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1049 order: 1
2025-09-13 16:39:56,023 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1051 order: 1
2025-09-13 16:39:56,041 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1053 order: 1
2025-09-13 16:39:56,372 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1089 order: 1
2025-09-13 16:39:56,413 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1093, order 1
2025-09-13 16:39:56,453 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1097, order 1
2025-09-13 16:39:56,507 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1103, order 1
2025-09-13 16:39:56,578 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1110, order 1
2025-09-13 16:39:56,716 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1125 order: 1
2025-09-13 16:39:56,862 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1142 order: 1
2025-09-13 16:39:56,911 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1147 order: 1
2025-09-13 16:39:56,973 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1154, order 1
2025-09-13 16:39:57,004 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1157, order 1
2025-09-13 16:39:57,036 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1160 order: 1
2025-09-13 16:39:57,112 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1169, order 1
2025-09-13 16:39:57,147 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1173, order 1
2025-09-13 16:39:57,200 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1179, order 1
2025-09-13 16:39:57,354 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1196 order: 1
2025-09-13 16:39:57,409 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1202, order 1
2025-09-13 16:39:57,419 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1203 order: 1
2025-09-13 16:39:57,440 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1205, order 1
2025-09-13 16:39:57,497 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1211, order 1
2025-09-13 16:39:57,584 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1220 order: 1
2025-09-13 16:39:57,613 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1223, order 1
2025-09-13 16:39:57,661 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1228, order 1
2025-09-13 16:39:57,698 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1232 order: 1
2025-09-13 16:39:57,708 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1233, order 1
2025-09-13 16:39:57,793 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1242 order: 1
2025-09-13 16:39:58,013 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1265 order: 1
2025-09-13 16:39:58,202 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1286, order 1
2025-09-13 16:39:58,254 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1291 order: 1
2025-09-13 16:39:58,283 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1294 order: 1
2025-09-13 16:39:58,310 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1297 order: 1
2025-09-13 16:39:58,395 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1306 order: 1
2025-09-13 16:39:58,524 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1320, order 1
2025-09-13 16:39:58,556 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1323, order 1
2025-09-13 16:39:58,909 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1361 order: 1
2025-09-13 16:39:59,041 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1374 order: 1
2025-09-13 16:39:59,091 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1379, order 1
2025-09-13 16:39:59,148 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1385 order: 1
2025-09-13 16:39:59,208 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1392 order: 1
2025-09-13 16:39:59,304 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1402 order: 1
2025-09-13 16:39:59,512 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1424 order: 1
2025-09-13 16:39:59,524 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1425, order 1
2025-09-13 16:39:59,676 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1441, order 1
2025-09-13 16:39:59,714 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1445 order: 1
2025-09-13 16:39:59,748 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1449 order: 1
2025-09-13 16:39:59,846 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1460 order: 1
2025-09-13 16:40:00,004 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1476 order: 1
2025-09-13 16:40:00,034 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1479 order: 1
2025-09-13 16:40:00,043 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1480 order: 1
2025-09-13 16:40:00,105 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1487, order 1
2025-09-13 16:40:00,146 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1491 order: 1
2025-09-13 16:40:00,164 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1493, order 1
2025-09-13 16:40:00,173 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1494, order 1
2025-09-13 16:40:00,182 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1495, order 1
2025-09-13 16:40:00,191 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1496, order 1
2025-09-13 16:40:00,200 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1497, order 1
2025-09-13 16:40:00,209 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1498, order 1
2025-09-13 16:40:00,218 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1499, order 1
2025-09-13 16:40:00,231 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1500, order 1
2025-09-13 16:40:00,243 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1501, order 1
2025-09-13 16:40:00,255 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1502, order 1
2025-09-13 16:40:00,259 - jwst.assign_wcs.util - INFO - Total of 100 grism objects defined
2025-09-13 16:40:00,283 - jwst.extract_2d.grisms - INFO - Grism object list created from source catalog: jw02079-o004_niriss_clear-f200w_cat.ecsv
2025-09-13 16:40:00,285 - jwst.extract_2d.grisms - INFO - Extracting 100 grism objects
2025-09-13 16:40:00,391 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 522 order: 1:
2025-09-13 16:40:00,392 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:513, xmax:783), (ymin:545, ymax:692)
2025-09-13 16:40:00,577 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 796 order: 1:
2025-09-13 16:40:00,578 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1694, xmax:1910), (ymin:971, ymax:1066)
2025-09-13 16:40:00,759 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 1479 order: 1:
2025-09-13 16:40:00,760 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:39, xmax:265), (ymin:2007, ymax:2048)
2025-09-13 16:40:00,940 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 214 order: 1:
2025-09-13 16:40:00,940 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:208, xmax:415), (ymin:117, ymax:221)
2025-09-13 16:40:01,120 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 693 order: 1:
2025-09-13 16:40:01,121 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:0, xmax:182), (ymin:801, ymax:876)
2025-09-13 16:40:01,297 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 1120 order: 1:
2025-09-13 16:40:01,298 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:407, xmax:639), (ymin:1430, ymax:1497)
2025-09-13 16:40:01,482 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 1257 order: 1:
2025-09-13 16:40:01,483 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1348, xmax:1574), (ymin:1624, ymax:1700)
2025-09-13 16:40:02,091 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 766 order: 1:
2025-09-13 16:40:02,091 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:849, xmax:1024), (ymin:928, ymax:1031)
2025-09-13 16:40:02,273 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 606 order: 1:
2025-09-13 16:40:02,274 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:307, xmax:500), (ymin:689, ymax:699)
2025-09-13 16:40:02,454 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 649 order: 1:
2025-09-13 16:40:02,454 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1435, xmax:1647), (ymin:731, ymax:825)
2025-09-13 16:40:02,637 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 982 order: 1:
2025-09-13 16:40:02,637 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:296, xmax:468), (ymin:1227, ymax:1281)
2025-09-13 16:40:02,817 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 1364 order: 1:
2025-09-13 16:40:02,818 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1258, xmax:1425), (ymin:1798, ymax:1858)
2025-09-13 16:40:03,000 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 898 order: 1:
2025-09-13 16:40:03,000 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1299, xmax:1466), (ymin:1144, ymax:1154)
2025-09-13 16:40:03,178 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 1049 order: 1:
2025-09-13 16:40:03,178 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:0, xmax:28), (ymin:1324, ymax:1400)
2025-09-13 16:40:03,351 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 732 order: 1:
2025-09-13 16:40:03,352 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:394, xmax:582), (ymin:871, ymax:914)
2025-09-13 16:40:03,531 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 189 order: 1:
2025-09-13 16:40:03,532 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1013, xmax:1183), (ymin:83, ymax:130)
2025-09-13 16:40:03,709 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 881 order: 1:
2025-09-13 16:40:03,710 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1015, xmax:1207), (ymin:1108, ymax:1118)
2025-09-13 16:40:03,888 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 966 order: 1:
2025-09-13 16:40:03,889 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1283, xmax:1460), (ymin:1218, ymax:1277)
2025-09-13 16:40:04,075 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 914 order: 1:
2025-09-13 16:40:04,075 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1662, xmax:1827), (ymin:1138, ymax:1169)
2025-09-13 16:40:04,253 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 1084 order: 1:
2025-09-13 16:40:04,254 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1687, xmax:1861), (ymin:1406, ymax:1416)
2025-09-13 16:40:04,428 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 540 order: 1:
2025-09-13 16:40:04,428 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1578, xmax:1763), (ymin:573, ymax:644)
2025-09-13 16:40:04,614 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 1476 order: 1:
2025-09-13 16:40:04,615 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:0, xmax:52), (ymin:2005, ymax:2048)
2025-09-13 16:40:04,796 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 1142 order: 1:
2025-09-13 16:40:04,797 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:0, xmax:134), (ymin:1460, ymax:1505)
2025-09-13 16:40:04,978 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 220 order: 1:
2025-09-13 16:40:04,979 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:24, xmax:194), (ymin:143, ymax:153)
2025-09-13 16:40:05,159 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 289 order: 1:
2025-09-13 16:40:05,159 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1755, xmax:1925), (ymin:229, ymax:265)
2025-09-13 16:40:05,340 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 934 order: 1:
2025-09-13 16:40:05,341 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:575, xmax:748), (ymin:1164, ymax:1210)
2025-09-13 16:40:05,519 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 1219 order: 1:
2025-09-13 16:40:05,520 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:812, xmax:980), (ymin:1576, ymax:1635)
2025-09-13 16:40:05,701 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 927 order: 1:
2025-09-13 16:40:05,702 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:673, xmax:848), (ymin:1151, ymax:1194)
2025-09-13 16:40:05,884 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 1417 order: 1:
2025-09-13 16:40:05,884 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:22, xmax:185), (ymin:1894, ymax:1932)
2025-09-13 16:40:06,059 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 567 order: 1:
2025-09-13 16:40:06,059 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1542, xmax:1709), (ymin:621, ymax:669)
2025-09-13 16:40:06,240 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 1296 order: 1:
2025-09-13 16:40:06,240 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:517, xmax:682), (ymin:1679, ymax:1721)
2025-09-13 16:40:06,419 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 1412 order: 1:
2025-09-13 16:40:06,420 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:738, xmax:901), (ymin:1890, ymax:1928)
2025-09-13 16:40:06,599 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 654 order: 1:
2025-09-13 16:40:06,600 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1648, xmax:1836), (ymin:740, ymax:799)
2025-09-13 16:40:06,780 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 1029 order: 1:
2025-09-13 16:40:06,781 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:0, xmax:191), (ymin:1290, ymax:1346)
2025-09-13 16:40:06,959 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 553 order: 1:
2025-09-13 16:40:06,960 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:314, xmax:484), (ymin:588, ymax:622)
2025-09-13 16:40:07,140 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 1387 order: 1:
2025-09-13 16:40:07,141 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1870, xmax:2031), (ymin:1844, ymax:1884)
2025-09-13 16:40:07,817 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 422 order: 1:
2025-09-13 16:40:07,817 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1425, xmax:1579), (ymin:397, ymax:425)
2025-09-13 16:40:07,993 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 821 order: 1:
2025-09-13 16:40:07,993 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:0, xmax:148), (ymin:989, ymax:1032)
2025-09-13 16:40:08,171 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 682 order: 1:
2025-09-13 16:40:08,171 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:843, xmax:1007), (ymin:795, ymax:844)
2025-09-13 16:40:08,352 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 1140 order: 1:
2025-09-13 16:40:08,352 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1506, xmax:1676), (ymin:1467, ymax:1508)
2025-09-13 16:40:08,534 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 1388 order: 1:
2025-09-13 16:40:08,534 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1642, xmax:1816), (ymin:1845, ymax:1903)
2025-09-13 16:40:08,714 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 759 order: 1:
2025-09-13 16:40:08,715 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1039, xmax:1207), (ymin:920, ymax:960)
2025-09-13 16:40:08,892 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 1407 order: 1:
2025-09-13 16:40:08,893 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1136, xmax:1300), (ymin:1874, ymax:1908)
2025-09-13 16:40:09,070 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 1194 order: 1:
2025-09-13 16:40:09,071 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1561, xmax:1725), (ymin:1529, ymax:1557)
2025-09-13 16:40:09,247 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 712 order: 1:
2025-09-13 16:40:09,247 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1177, xmax:1340), (ymin:840, ymax:874)
2025-09-13 16:40:09,421 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 539 order: 1:
2025-09-13 16:40:09,422 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1488, xmax:1638), (ymin:572, ymax:614)
2025-09-13 16:40:09,601 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 1008 order: 1:
2025-09-13 16:40:09,602 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:899, xmax:1054), (ymin:1269, ymax:1300)
2025-09-13 16:40:09,779 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 347 order: 1:
2025-09-13 16:40:09,780 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:578, xmax:732), (ymin:303, ymax:313)
2025-09-13 16:40:09,957 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 276 order: 1:
2025-09-13 16:40:09,958 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1171, xmax:1336), (ymin:206, ymax:250)
2025-09-13 16:40:10,138 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 605 order: 1:
2025-09-13 16:40:10,139 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:208, xmax:354), (ymin:666, ymax:676)
2025-09-13 16:40:10,315 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 922 order: 1:
2025-09-13 16:40:10,316 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1589, xmax:1742), (ymin:1147, ymax:1177)
2025-09-13 16:40:10,491 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 736 order: 1:
2025-09-13 16:40:10,492 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1913, xmax:2048), (ymin:885, ymax:907)
2025-09-13 16:40:10,666 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 1423 order: 1:
2025-09-13 16:40:10,667 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:78, xmax:235), (ymin:1915, ymax:1946)
2025-09-13 16:40:10,843 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 800 order: 1:
2025-09-13 16:40:10,844 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:665, xmax:815), (ymin:970, ymax:996)
2025-09-13 16:40:11,019 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 873 order: 1:
2025-09-13 16:40:11,019 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1880, xmax:2024), (ymin:1078, ymax:1105)
2025-09-13 16:40:11,195 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 385 order: 1:
2025-09-13 16:40:11,196 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:302, xmax:466), (ymin:337, ymax:358)
2025-09-13 16:40:11,369 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 557 order: 1:
2025-09-13 16:40:11,370 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:200, xmax:361), (ymin:600, ymax:637)
2025-09-13 16:40:11,544 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 719 order: 1:
2025-09-13 16:40:11,544 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1463, xmax:1610), (ymin:852, ymax:880)
2025-09-13 16:40:11,719 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 389 order: 1:
2025-09-13 16:40:11,719 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:358, xmax:513), (ymin:341, ymax:371)
2025-09-13 16:40:11,897 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 733 order: 1:
2025-09-13 16:40:11,897 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1731, xmax:1907), (ymin:880, ymax:924)
2025-09-13 16:40:12,076 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 1442 order: 1:
2025-09-13 16:40:12,077 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:553, xmax:721), (ymin:1949, ymax:1993)
2025-09-13 16:40:12,255 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 417 order: 1:
2025-09-13 16:40:12,256 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:811, xmax:959), (ymin:384, ymax:412)
2025-09-13 16:40:12,435 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 630 order: 1:
2025-09-13 16:40:12,436 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1778, xmax:1919), (ymin:699, ymax:709)
2025-09-13 16:40:12,612 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 925 order: 1:
2025-09-13 16:40:12,613 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:293, xmax:459), (ymin:1143, ymax:1175)
2025-09-13 16:40:12,791 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 527 order: 1:
2025-09-13 16:40:12,791 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1770, xmax:1921), (ymin:559, ymax:594)
2025-09-13 16:40:12,969 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 439 order: 1:
2025-09-13 16:40:12,969 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:674, xmax:834), (ymin:424, ymax:434)
2025-09-13 16:40:13,734 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 1253 order: 1:
2025-09-13 16:40:13,734 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:122, xmax:270), (ymin:1614, ymax:1647)
2025-09-13 16:40:13,912 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 1162 order: 1:
2025-09-13 16:40:13,913 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:804, xmax:948), (ymin:1486, ymax:1504)
2025-09-13 16:40:14,088 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 1457 order: 1:
2025-09-13 16:40:14,089 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:158, xmax:305), (ymin:1975, ymax:1999)
2025-09-13 16:40:14,267 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 694 order: 1:
2025-09-13 16:40:14,267 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:242, xmax:409), (ymin:803, ymax:824)
2025-09-13 16:40:14,446 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 1266 order: 1:
2025-09-13 16:40:14,447 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:706, xmax:867), (ymin:1637, ymax:1663)
2025-09-13 16:40:14,624 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 298 order: 1:
2025-09-13 16:40:14,624 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1041, xmax:1196), (ymin:235, ymax:258)
2025-09-13 16:40:14,801 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 516 order: 1:
2025-09-13 16:40:14,802 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:472, xmax:625), (ymin:537, ymax:570)
2025-09-13 16:40:14,978 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 973 order: 1:
2025-09-13 16:40:14,978 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:447, xmax:593), (ymin:1220, ymax:1240)
2025-09-13 16:40:15,156 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 180 order: 1:
2025-09-13 16:40:15,157 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1370, xmax:1535), (ymin:73, ymax:105)
2025-09-13 16:40:15,335 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 980 order: 1:
2025-09-13 16:40:15,336 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1355, xmax:1517), (ymin:1232, ymax:1261)
2025-09-13 16:40:15,513 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 263 order: 1:
2025-09-13 16:40:15,514 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:826, xmax:987), (ymin:177, ymax:201)
2025-09-13 16:40:15,692 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 493 order: 1:
2025-09-13 16:40:15,693 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1408, xmax:1560), (ymin:503, ymax:533)
2025-09-13 16:40:15,869 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 981 order: 1:
2025-09-13 16:40:15,870 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1726, xmax:1867), (ymin:1233, ymax:1256)
2025-09-13 16:40:16,044 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 1371 order: 1:
2025-09-13 16:40:16,045 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:622, xmax:769), (ymin:1806, ymax:1828)
2025-09-13 16:40:16,221 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 536 order: 1:
2025-09-13 16:40:16,222 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:374, xmax:521), (ymin:561, ymax:595)
2025-09-13 16:40:16,398 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 749 order: 1:
2025-09-13 16:40:16,398 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1483, xmax:1631), (ymin:907, ymax:929)
2025-09-13 16:40:16,573 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 345 order: 1:
2025-09-13 16:40:16,574 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:849, xmax:993), (ymin:292, ymax:313)
2025-09-13 16:40:16,745 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 721 order: 1:
2025-09-13 16:40:16,746 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:117, xmax:257), (ymin:848, ymax:858)
2025-09-13 16:40:16,921 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 387 order: 1:
2025-09-13 16:40:16,922 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1383, xmax:1529), (ymin:346, ymax:364)
2025-09-13 16:40:17,093 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 505 order: 1:
2025-09-13 16:40:17,094 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1438, xmax:1582), (ymin:533, ymax:554)
2025-09-13 16:40:17,266 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 566 order: 1:
2025-09-13 16:40:17,267 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1112, xmax:1258), (ymin:619, ymax:654)
2025-09-13 16:40:17,439 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 772 order: 1:
2025-09-13 16:40:17,440 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1615, xmax:1762), (ymin:937, ymax:962)
2025-09-13 16:40:17,618 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 722 order: 1:
2025-09-13 16:40:17,618 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:388, xmax:542), (ymin:848, ymax:874)
2025-09-13 16:40:17,793 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 872 order: 1:
2025-09-13 16:40:17,794 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1419, xmax:1567), (ymin:1079, ymax:1089)
2025-09-13 16:40:17,967 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 933 order: 1:
2025-09-13 16:40:17,968 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:24, xmax:184), (ymin:1160, ymax:1184)
2025-09-13 16:40:18,143 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 1128 order: 1:
2025-09-13 16:40:18,143 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1689, xmax:1827), (ymin:1451, ymax:1461)
2025-09-13 16:40:18,316 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 1282 order: 1:
2025-09-13 16:40:18,317 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:796, xmax:953), (ymin:1667, ymax:1702)
2025-09-13 16:40:18,491 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 274 order: 1:
2025-09-13 16:40:18,492 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:388, xmax:542), (ymin:193, ymax:224)
2025-09-13 16:40:18,666 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 641 order: 1:
2025-09-13 16:40:18,667 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1522, xmax:1673), (ymin:715, ymax:738)
2025-09-13 16:40:18,839 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 543 order: 1:
2025-09-13 16:40:18,840 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:129, xmax:283), (ymin:570, ymax:599)
2025-09-13 16:40:19,016 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 610 order: 1:
2025-09-13 16:40:19,016 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:0, xmax:15), (ymin:684, ymax:694)
2025-09-13 16:40:19,189 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 1188 order: 1:
2025-09-13 16:40:19,190 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:438, xmax:579), (ymin:1517, ymax:1554)
2025-09-13 16:40:19,364 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 533 order: 1:
2025-09-13 16:40:19,364 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1317, xmax:1464), (ymin:564, ymax:585)
2025-09-13 16:40:19,536 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 1342 order: 1:
2025-09-13 16:40:19,536 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1383, xmax:1527), (ymin:1762, ymax:1784)
2025-09-13 16:40:22,705 - jwst.extract_2d.grisms - INFO - Finished extractions
2025-09-13 16:40:22,736 - stpipe.Spec2Pipeline.extract_2d - INFO - Step extract_2d done
2025-09-13 16:40:23,263 - stpipe.Spec2Pipeline.srctype - INFO - Step srctype running with args (<MultiSlitModel from jw02079004003_05101_00001_nis_rate.fits>,).
2025-09-13 16:40:23,270 - jwst.srctype.srctype - INFO - Input EXP_TYPE is NIS_WFSS
2025-09-13 16:40:23,270 - jwst.srctype.srctype - INFO - source_id=522, type=EXTENDED
2025-09-13 16:40:23,271 - jwst.srctype.srctype - INFO - source_id=796, type=EXTENDED
2025-09-13 16:40:23,272 - jwst.srctype.srctype - INFO - source_id=1479, type=EXTENDED
2025-09-13 16:40:23,272 - jwst.srctype.srctype - INFO - source_id=214, type=EXTENDED
2025-09-13 16:40:23,273 - jwst.srctype.srctype - INFO - source_id=693, type=EXTENDED
2025-09-13 16:40:23,274 - jwst.srctype.srctype - INFO - source_id=1120, type=EXTENDED
2025-09-13 16:40:23,274 - jwst.srctype.srctype - INFO - source_id=1257, type=EXTENDED
2025-09-13 16:40:23,275 - jwst.srctype.srctype - INFO - source_id=766, type=EXTENDED
2025-09-13 16:40:23,275 - jwst.srctype.srctype - INFO - source_id=606, type=POINT
2025-09-13 16:40:23,276 - jwst.srctype.srctype - INFO - source_id=649, type=EXTENDED
2025-09-13 16:40:23,276 - jwst.srctype.srctype - INFO - source_id=982, type=EXTENDED
2025-09-13 16:40:23,277 - jwst.srctype.srctype - INFO - source_id=1364, type=EXTENDED
2025-09-13 16:40:23,278 - jwst.srctype.srctype - INFO - source_id=898, type=POINT
2025-09-13 16:40:23,278 - jwst.srctype.srctype - INFO - source_id=1049, type=EXTENDED
2025-09-13 16:40:23,279 - jwst.srctype.srctype - INFO - source_id=732, type=EXTENDED
2025-09-13 16:40:23,280 - jwst.srctype.srctype - INFO - source_id=189, type=EXTENDED
2025-09-13 16:40:23,280 - jwst.srctype.srctype - INFO - source_id=881, type=POINT
2025-09-13 16:40:23,281 - jwst.srctype.srctype - INFO - source_id=966, type=EXTENDED
2025-09-13 16:40:23,281 - jwst.srctype.srctype - INFO - source_id=914, type=EXTENDED
2025-09-13 16:40:23,282 - jwst.srctype.srctype - INFO - source_id=1084, type=POINT
2025-09-13 16:40:23,282 - jwst.srctype.srctype - INFO - source_id=540, type=EXTENDED
2025-09-13 16:40:23,283 - jwst.srctype.srctype - INFO - source_id=1476, type=EXTENDED
2025-09-13 16:40:23,284 - jwst.srctype.srctype - INFO - source_id=1142, type=EXTENDED
2025-09-13 16:40:23,284 - jwst.srctype.srctype - INFO - source_id=220, type=POINT
2025-09-13 16:40:23,285 - jwst.srctype.srctype - INFO - source_id=289, type=EXTENDED
2025-09-13 16:40:23,285 - jwst.srctype.srctype - INFO - source_id=934, type=EXTENDED
2025-09-13 16:40:23,286 - jwst.srctype.srctype - INFO - source_id=1219, type=EXTENDED
2025-09-13 16:40:23,286 - jwst.srctype.srctype - INFO - source_id=927, type=EXTENDED
2025-09-13 16:40:23,287 - jwst.srctype.srctype - INFO - source_id=1417, type=EXTENDED
2025-09-13 16:40:23,287 - jwst.srctype.srctype - INFO - source_id=567, type=EXTENDED
2025-09-13 16:40:23,288 - jwst.srctype.srctype - INFO - source_id=1296, type=EXTENDED
2025-09-13 16:40:23,288 - jwst.srctype.srctype - INFO - source_id=1412, type=EXTENDED
2025-09-13 16:40:23,289 - jwst.srctype.srctype - INFO - source_id=654, type=EXTENDED
2025-09-13 16:40:23,289 - jwst.srctype.srctype - INFO - source_id=1029, type=EXTENDED
2025-09-13 16:40:23,290 - jwst.srctype.srctype - INFO - source_id=553, type=EXTENDED
2025-09-13 16:40:23,291 - jwst.srctype.srctype - INFO - source_id=1387, type=EXTENDED
2025-09-13 16:40:23,291 - jwst.srctype.srctype - INFO - source_id=422, type=EXTENDED
2025-09-13 16:40:23,292 - jwst.srctype.srctype - INFO - source_id=821, type=EXTENDED
2025-09-13 16:40:23,292 - jwst.srctype.srctype - INFO - source_id=682, type=EXTENDED
2025-09-13 16:40:23,293 - jwst.srctype.srctype - INFO - source_id=1140, type=EXTENDED
2025-09-13 16:40:23,293 - jwst.srctype.srctype - INFO - source_id=1388, type=EXTENDED
2025-09-13 16:40:23,294 - jwst.srctype.srctype - INFO - source_id=759, type=EXTENDED
2025-09-13 16:40:23,294 - jwst.srctype.srctype - INFO - source_id=1407, type=EXTENDED
2025-09-13 16:40:23,295 - jwst.srctype.srctype - INFO - source_id=1194, type=EXTENDED
2025-09-13 16:40:23,295 - jwst.srctype.srctype - INFO - source_id=712, type=EXTENDED
2025-09-13 16:40:23,296 - jwst.srctype.srctype - INFO - source_id=539, type=EXTENDED
2025-09-13 16:40:23,296 - jwst.srctype.srctype - INFO - source_id=1008, type=EXTENDED
2025-09-13 16:40:23,297 - jwst.srctype.srctype - INFO - source_id=347, type=POINT
2025-09-13 16:40:23,297 - jwst.srctype.srctype - INFO - source_id=276, type=EXTENDED
2025-09-13 16:40:23,298 - jwst.srctype.srctype - INFO - source_id=605, type=POINT
2025-09-13 16:40:23,298 - jwst.srctype.srctype - INFO - source_id=922, type=EXTENDED
2025-09-13 16:40:23,299 - jwst.srctype.srctype - INFO - source_id=736, type=EXTENDED
2025-09-13 16:40:23,299 - jwst.srctype.srctype - INFO - source_id=1423, type=EXTENDED
2025-09-13 16:40:23,301 - jwst.srctype.srctype - INFO - source_id=800, type=EXTENDED
2025-09-13 16:40:23,301 - jwst.srctype.srctype - INFO - source_id=873, type=EXTENDED
2025-09-13 16:40:23,302 - jwst.srctype.srctype - INFO - source_id=385, type=EXTENDED
2025-09-13 16:40:23,302 - jwst.srctype.srctype - INFO - source_id=557, type=EXTENDED
2025-09-13 16:40:23,303 - jwst.srctype.srctype - INFO - source_id=719, type=EXTENDED
2025-09-13 16:40:23,303 - jwst.srctype.srctype - INFO - source_id=389, type=EXTENDED
2025-09-13 16:40:23,304 - jwst.srctype.srctype - INFO - source_id=733, type=EXTENDED
2025-09-13 16:40:23,304 - jwst.srctype.srctype - INFO - source_id=1442, type=EXTENDED
2025-09-13 16:40:23,304 - jwst.srctype.srctype - INFO - source_id=417, type=EXTENDED
2025-09-13 16:40:23,305 - jwst.srctype.srctype - INFO - source_id=630, type=POINT
2025-09-13 16:40:23,305 - jwst.srctype.srctype - INFO - source_id=925, type=EXTENDED
2025-09-13 16:40:23,306 - jwst.srctype.srctype - INFO - source_id=527, type=EXTENDED
2025-09-13 16:40:23,306 - jwst.srctype.srctype - INFO - source_id=439, type=POINT
2025-09-13 16:40:23,307 - jwst.srctype.srctype - INFO - source_id=1253, type=EXTENDED
2025-09-13 16:40:23,307 - jwst.srctype.srctype - INFO - source_id=1162, type=EXTENDED
2025-09-13 16:40:23,308 - jwst.srctype.srctype - INFO - source_id=1457, type=EXTENDED
2025-09-13 16:40:23,308 - jwst.srctype.srctype - INFO - source_id=694, type=EXTENDED
2025-09-13 16:40:23,309 - jwst.srctype.srctype - INFO - source_id=1266, type=EXTENDED
2025-09-13 16:40:23,309 - jwst.srctype.srctype - INFO - source_id=298, type=EXTENDED
2025-09-13 16:40:23,310 - jwst.srctype.srctype - INFO - source_id=516, type=EXTENDED
2025-09-13 16:40:23,311 - jwst.srctype.srctype - INFO - source_id=973, type=EXTENDED
2025-09-13 16:40:23,311 - jwst.srctype.srctype - INFO - source_id=180, type=EXTENDED
2025-09-13 16:40:23,312 - jwst.srctype.srctype - INFO - source_id=980, type=EXTENDED
2025-09-13 16:40:23,312 - jwst.srctype.srctype - INFO - source_id=263, type=EXTENDED
2025-09-13 16:40:23,313 - jwst.srctype.srctype - INFO - source_id=493, type=EXTENDED
2025-09-13 16:40:23,313 - jwst.srctype.srctype - INFO - source_id=981, type=EXTENDED
2025-09-13 16:40:23,314 - jwst.srctype.srctype - INFO - source_id=1371, type=EXTENDED
2025-09-13 16:40:23,314 - jwst.srctype.srctype - INFO - source_id=536, type=EXTENDED
2025-09-13 16:40:23,315 - jwst.srctype.srctype - INFO - source_id=749, type=EXTENDED
2025-09-13 16:40:23,315 - jwst.srctype.srctype - INFO - source_id=345, type=EXTENDED
2025-09-13 16:40:23,316 - jwst.srctype.srctype - INFO - source_id=721, type=POINT
2025-09-13 16:40:23,316 - jwst.srctype.srctype - INFO - source_id=387, type=EXTENDED
2025-09-13 16:40:23,317 - jwst.srctype.srctype - INFO - source_id=505, type=EXTENDED
2025-09-13 16:40:23,317 - jwst.srctype.srctype - INFO - source_id=566, type=EXTENDED
2025-09-13 16:40:23,318 - jwst.srctype.srctype - INFO - source_id=772, type=EXTENDED
2025-09-13 16:40:23,318 - jwst.srctype.srctype - INFO - source_id=722, type=EXTENDED
2025-09-13 16:40:23,319 - jwst.srctype.srctype - INFO - source_id=872, type=POINT
2025-09-13 16:40:23,319 - jwst.srctype.srctype - INFO - source_id=933, type=EXTENDED
2025-09-13 16:40:23,320 - jwst.srctype.srctype - INFO - source_id=1128, type=POINT
2025-09-13 16:40:23,321 - jwst.srctype.srctype - INFO - source_id=1282, type=EXTENDED
2025-09-13 16:40:23,321 - jwst.srctype.srctype - INFO - source_id=274, type=EXTENDED
2025-09-13 16:40:23,322 - jwst.srctype.srctype - INFO - source_id=641, type=EXTENDED
2025-09-13 16:40:23,322 - jwst.srctype.srctype - INFO - source_id=543, type=EXTENDED
2025-09-13 16:40:23,322 - jwst.srctype.srctype - INFO - source_id=610, type=POINT
2025-09-13 16:40:23,323 - jwst.srctype.srctype - INFO - source_id=1188, type=EXTENDED
2025-09-13 16:40:23,323 - jwst.srctype.srctype - INFO - source_id=533, type=EXTENDED
2025-09-13 16:40:23,324 - jwst.srctype.srctype - INFO - source_id=1342, type=EXTENDED
2025-09-13 16:40:23,326 - stpipe.Spec2Pipeline.srctype - INFO - Step srctype done
2025-09-13 16:40:23,852 - stpipe.Spec2Pipeline.straylight - INFO - Step straylight running with args (<MultiSlitModel from jw02079004003_05101_00001_nis_rate.fits>,).
2025-09-13 16:40:23,854 - stpipe.Spec2Pipeline.straylight - INFO - Step skipped.
2025-09-13 16:40:24,350 - stpipe.Spec2Pipeline.fringe - INFO - Step fringe running with args (<MultiSlitModel from jw02079004003_05101_00001_nis_rate.fits>,).
2025-09-13 16:40:24,351 - stpipe.Spec2Pipeline.fringe - INFO - Step skipped.
2025-09-13 16:40:24,841 - stpipe.Spec2Pipeline.pathloss - INFO - Step pathloss running with args (<MultiSlitModel from jw02079004003_05101_00001_nis_rate.fits>,).
2025-09-13 16:40:24,841 - stpipe.Spec2Pipeline.pathloss - INFO - Step skipped.
2025-09-13 16:40:25,339 - stpipe.Spec2Pipeline.barshadow - INFO - Step barshadow running with args (<MultiSlitModel from jw02079004003_05101_00001_nis_rate.fits>,).
2025-09-13 16:40:25,339 - stpipe.Spec2Pipeline.barshadow - INFO - Step skipped.
2025-09-13 16:40:25,830 - stpipe.Spec2Pipeline.wfss_contam - INFO - Step wfss_contam running with args (<MultiSlitModel from jw02079004003_05101_00001_nis_rate.fits>,).
2025-09-13 16:40:25,831 - stpipe.Spec2Pipeline.wfss_contam - INFO - Step skipped.
2025-09-13 16:40:26,335 - stpipe.Spec2Pipeline.photom - INFO - Step photom running with args (<MultiSlitModel from jw02079004003_05101_00001_nis_rate.fits>,).
2025-09-13 16:40:26,384 - stpipe.Spec2Pipeline.photom - INFO - Using photom reference file: /home/runner/crds/references/jwst/niriss/jwst_niriss_photom_0041.fits
2025-09-13 16:40:26,384 - stpipe.Spec2Pipeline.photom - INFO - Using area reference file: N/A
2025-09-13 16:40:29,352 - jwst.photom.photom - INFO - Using instrument: NIRISS
2025-09-13 16:40:29,353 - jwst.photom.photom - INFO - detector: NIS
2025-09-13 16:40:29,353 - jwst.photom.photom - INFO - exp_type: NIS_WFSS
2025-09-13 16:40:29,354 - jwst.photom.photom - INFO - filter: GR150C
2025-09-13 16:40:29,354 - jwst.photom.photom - INFO - pupil: F200W
2025-09-13 16:40:29,373 - jwst.photom.photom - INFO - Attempting to obtain PIXAR_SR and PIXAR_A2 values from PHOTOM reference file.
2025-09-13 16:40:29,374 - jwst.photom.photom - INFO - Values for PIXAR_SR and PIXAR_A2 obtained from PHOTOM reference file.
2025-09-13 16:40:29,408 - jwst.photom.photom - INFO - Working on slit 522, order 1
2025-09-13 16:40:29,409 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:40:29,414 - jwst.photom.photom - INFO - Working on slit 796, order 1
2025-09-13 16:40:29,415 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:40:29,419 - jwst.photom.photom - INFO - Working on slit 1479, order 1
2025-09-13 16:40:29,420 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:40:29,423 - jwst.photom.photom - INFO - Working on slit 214, order 1
2025-09-13 16:40:29,424 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:40:29,428 - jwst.photom.photom - INFO - Working on slit 693, order 1
2025-09-13 16:40:29,429 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:40:29,433 - jwst.photom.photom - INFO - Working on slit 1120, order 1
2025-09-13 16:40:29,433 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:40:29,437 - jwst.photom.photom - INFO - Working on slit 1257, order 1
2025-09-13 16:40:29,438 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:40:29,442 - jwst.photom.photom - INFO - Working on slit 766, order 1
2025-09-13 16:40:29,442 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:40:29,447 - jwst.photom.photom - INFO - Working on slit 606, order 1
2025-09-13 16:40:29,447 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:40:29,451 - jwst.photom.photom - INFO - Working on slit 649, order 1
2025-09-13 16:40:29,451 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:40:29,456 - jwst.photom.photom - INFO - Working on slit 982, order 1
2025-09-13 16:40:29,456 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:40:29,460 - jwst.photom.photom - INFO - Working on slit 1364, order 1
2025-09-13 16:40:29,460 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:40:29,464 - jwst.photom.photom - INFO - Working on slit 898, order 1
2025-09-13 16:40:29,465 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:40:29,468 - jwst.photom.photom - INFO - Working on slit 1049, order 1
2025-09-13 16:40:29,469 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:40:29,472 - jwst.photom.photom - INFO - Working on slit 732, order 1
2025-09-13 16:40:29,473 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:40:29,477 - jwst.photom.photom - INFO - Working on slit 189, order 1
2025-09-13 16:40:29,478 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:40:29,481 - jwst.photom.photom - INFO - Working on slit 881, order 1
2025-09-13 16:40:29,481 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:40:29,485 - jwst.photom.photom - INFO - Working on slit 966, order 1
2025-09-13 16:40:29,486 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:40:29,489 - jwst.photom.photom - INFO - Working on slit 914, order 1
2025-09-13 16:40:29,490 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:40:29,494 - jwst.photom.photom - INFO - Working on slit 1084, order 1
2025-09-13 16:40:29,494 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:40:29,498 - jwst.photom.photom - INFO - Working on slit 540, order 1
2025-09-13 16:40:29,498 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:40:29,502 - jwst.photom.photom - INFO - Working on slit 1476, order 1
2025-09-13 16:40:29,503 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:40:29,506 - jwst.photom.photom - INFO - Working on slit 1142, order 1
2025-09-13 16:40:29,507 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:40:29,511 - jwst.photom.photom - INFO - Working on slit 220, order 1
2025-09-13 16:40:29,512 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:40:29,515 - jwst.photom.photom - INFO - Working on slit 289, order 1
2025-09-13 16:40:29,515 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:40:29,519 - jwst.photom.photom - INFO - Working on slit 934, order 1
2025-09-13 16:40:29,520 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:40:29,523 - jwst.photom.photom - INFO - Working on slit 1219, order 1
2025-09-13 16:40:29,524 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:40:29,527 - jwst.photom.photom - INFO - Working on slit 927, order 1
2025-09-13 16:40:29,528 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:40:29,532 - jwst.photom.photom - INFO - Working on slit 1417, order 1
2025-09-13 16:40:29,533 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:40:29,536 - jwst.photom.photom - INFO - Working on slit 567, order 1
2025-09-13 16:40:29,537 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:40:29,541 - jwst.photom.photom - INFO - Working on slit 1296, order 1
2025-09-13 16:40:29,541 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:40:29,545 - jwst.photom.photom - INFO - Working on slit 1412, order 1
2025-09-13 16:40:29,545 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:40:29,549 - jwst.photom.photom - INFO - Working on slit 654, order 1
2025-09-13 16:40:29,550 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:40:29,554 - jwst.photom.photom - INFO - Working on slit 1029, order 1
2025-09-13 16:40:29,554 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:40:29,558 - jwst.photom.photom - INFO - Working on slit 553, order 1
2025-09-13 16:40:29,559 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:40:29,562 - jwst.photom.photom - INFO - Working on slit 1387, order 1
2025-09-13 16:40:29,563 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:40:29,567 - jwst.photom.photom - INFO - Working on slit 422, order 1
2025-09-13 16:40:29,567 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:40:29,571 - jwst.photom.photom - INFO - Working on slit 821, order 1
2025-09-13 16:40:29,571 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:40:29,575 - jwst.photom.photom - INFO - Working on slit 682, order 1
2025-09-13 16:40:29,576 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:40:29,579 - jwst.photom.photom - INFO - Working on slit 1140, order 1
2025-09-13 16:40:29,580 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:40:29,584 - jwst.photom.photom - INFO - Working on slit 1388, order 1
2025-09-13 16:40:29,585 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:40:29,588 - jwst.photom.photom - INFO - Working on slit 759, order 1
2025-09-13 16:40:29,589 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:40:29,592 - jwst.photom.photom - INFO - Working on slit 1407, order 1
2025-09-13 16:40:29,593 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:40:29,596 - jwst.photom.photom - INFO - Working on slit 1194, order 1
2025-09-13 16:40:29,597 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:40:29,600 - jwst.photom.photom - INFO - Working on slit 712, order 1
2025-09-13 16:40:29,601 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:40:29,605 - jwst.photom.photom - INFO - Working on slit 539, order 1
2025-09-13 16:40:29,605 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:40:29,609 - jwst.photom.photom - INFO - Working on slit 1008, order 1
2025-09-13 16:40:29,609 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:40:29,613 - jwst.photom.photom - INFO - Working on slit 347, order 1
2025-09-13 16:40:29,614 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:40:29,617 - jwst.photom.photom - INFO - Working on slit 276, order 1
2025-09-13 16:40:29,618 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:40:29,622 - jwst.photom.photom - INFO - Working on slit 605, order 1
2025-09-13 16:40:29,623 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:40:29,626 - jwst.photom.photom - INFO - Working on slit 922, order 1
2025-09-13 16:40:29,626 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:40:29,630 - jwst.photom.photom - INFO - Working on slit 736, order 1
2025-09-13 16:40:29,631 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:40:29,634 - jwst.photom.photom - INFO - Working on slit 1423, order 1
2025-09-13 16:40:29,635 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:40:29,639 - jwst.photom.photom - INFO - Working on slit 800, order 1
2025-09-13 16:40:29,639 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:40:29,643 - jwst.photom.photom - INFO - Working on slit 873, order 1
2025-09-13 16:40:29,643 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:40:29,647 - jwst.photom.photom - INFO - Working on slit 385, order 1
2025-09-13 16:40:29,647 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:40:29,651 - jwst.photom.photom - INFO - Working on slit 557, order 1
2025-09-13 16:40:29,652 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:40:29,655 - jwst.photom.photom - INFO - Working on slit 719, order 1
2025-09-13 16:40:29,656 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:40:29,660 - jwst.photom.photom - INFO - Working on slit 389, order 1
2025-09-13 16:40:29,660 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:40:29,664 - jwst.photom.photom - INFO - Working on slit 733, order 1
2025-09-13 16:40:29,664 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:40:29,668 - jwst.photom.photom - INFO - Working on slit 1442, order 1
2025-09-13 16:40:29,669 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:40:29,673 - jwst.photom.photom - INFO - Working on slit 417, order 1
2025-09-13 16:40:29,673 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:40:29,677 - jwst.photom.photom - INFO - Working on slit 630, order 1
2025-09-13 16:40:29,678 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:40:29,681 - jwst.photom.photom - INFO - Working on slit 925, order 1
2025-09-13 16:40:29,682 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:40:29,686 - jwst.photom.photom - INFO - Working on slit 527, order 1
2025-09-13 16:40:29,686 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:40:29,690 - jwst.photom.photom - INFO - Working on slit 439, order 1
2025-09-13 16:40:29,690 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:40:29,694 - jwst.photom.photom - INFO - Working on slit 1253, order 1
2025-09-13 16:40:29,695 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:40:29,698 - jwst.photom.photom - INFO - Working on slit 1162, order 1
2025-09-13 16:40:29,699 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:40:29,702 - jwst.photom.photom - INFO - Working on slit 1457, order 1
2025-09-13 16:40:29,703 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:40:29,706 - jwst.photom.photom - INFO - Working on slit 694, order 1
2025-09-13 16:40:29,707 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:40:29,710 - jwst.photom.photom - INFO - Working on slit 1266, order 1
2025-09-13 16:40:29,711 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:40:29,715 - jwst.photom.photom - INFO - Working on slit 298, order 1
2025-09-13 16:40:29,716 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:40:29,719 - jwst.photom.photom - INFO - Working on slit 516, order 1
2025-09-13 16:40:29,720 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:40:29,723 - jwst.photom.photom - INFO - Working on slit 973, order 1
2025-09-13 16:40:29,724 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:40:29,727 - jwst.photom.photom - INFO - Working on slit 180, order 1
2025-09-13 16:40:29,728 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:40:29,732 - jwst.photom.photom - INFO - Working on slit 980, order 1
2025-09-13 16:40:29,733 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:40:29,736 - jwst.photom.photom - INFO - Working on slit 263, order 1
2025-09-13 16:40:29,737 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:40:29,741 - jwst.photom.photom - INFO - Working on slit 493, order 1
2025-09-13 16:40:29,741 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:40:29,745 - jwst.photom.photom - INFO - Working on slit 981, order 1
2025-09-13 16:40:29,745 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:40:29,749 - jwst.photom.photom - INFO - Working on slit 1371, order 1
2025-09-13 16:40:29,749 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:40:29,753 - jwst.photom.photom - INFO - Working on slit 536, order 1
2025-09-13 16:40:29,754 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:40:29,757 - jwst.photom.photom - INFO - Working on slit 749, order 1
2025-09-13 16:40:29,758 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:40:29,762 - jwst.photom.photom - INFO - Working on slit 345, order 1
2025-09-13 16:40:29,762 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:40:29,766 - jwst.photom.photom - INFO - Working on slit 721, order 1
2025-09-13 16:40:29,766 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:40:29,770 - jwst.photom.photom - INFO - Working on slit 387, order 1
2025-09-13 16:40:29,771 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:40:29,774 - jwst.photom.photom - INFO - Working on slit 505, order 1
2025-09-13 16:40:29,775 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:40:29,778 - jwst.photom.photom - INFO - Working on slit 566, order 1
2025-09-13 16:40:29,779 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:40:29,782 - jwst.photom.photom - INFO - Working on slit 772, order 1
2025-09-13 16:40:29,783 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:40:29,787 - jwst.photom.photom - INFO - Working on slit 722, order 1
2025-09-13 16:40:29,787 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:40:29,791 - jwst.photom.photom - INFO - Working on slit 872, order 1
2025-09-13 16:40:29,791 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:40:29,795 - jwst.photom.photom - INFO - Working on slit 933, order 1
2025-09-13 16:40:29,796 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:40:29,799 - jwst.photom.photom - INFO - Working on slit 1128, order 1
2025-09-13 16:40:29,800 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:40:29,803 - jwst.photom.photom - INFO - Working on slit 1282, order 1
2025-09-13 16:40:29,804 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:40:29,808 - jwst.photom.photom - INFO - Working on slit 274, order 1
2025-09-13 16:40:29,808 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:40:29,812 - jwst.photom.photom - INFO - Working on slit 641, order 1
2025-09-13 16:40:29,812 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:40:29,816 - jwst.photom.photom - INFO - Working on slit 543, order 1
2025-09-13 16:40:29,817 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:40:29,820 - jwst.photom.photom - INFO - Working on slit 610, order 1
2025-09-13 16:40:29,821 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:40:29,824 - jwst.photom.photom - INFO - Working on slit 1188, order 1
2025-09-13 16:40:29,825 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:40:29,828 - jwst.photom.photom - INFO - Working on slit 533, order 1
2025-09-13 16:40:29,829 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:40:29,833 - jwst.photom.photom - INFO - Working on slit 1342, order 1
2025-09-13 16:40:29,833 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:40:29,841 - stpipe.Spec2Pipeline.photom - INFO - Step photom done
2025-09-13 16:40:32,842 - stpipe.Spec2Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<MultiSlitModel from /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage2_spec/jw02079004003_05101_00001_nis_cal.fits>,).
2025-09-13 16:40:32,845 - stpipe.Spec2Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 16:40:35,812 - stpipe.Spec2Pipeline.extract_1d - INFO - Step extract_1d running with args (<MultiSlitModel from /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage2_spec/jw02079004003_05101_00001_nis_cal.fits>,).
2025-09-13 16:40:35,934 - stpipe.Spec2Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 16:40:35,985 - jwst.extract_1d.extract - INFO - Working on slit 522
2025-09-13 16:40:35,986 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:40:35,987 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 147.00 (inclusive)
2025-09-13 16:40:36,043 - jwst.extract_1d.extract - INFO - Working on slit 796
2025-09-13 16:40:36,044 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:40:36,045 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 95.00 (inclusive)
2025-09-13 16:40:36,098 - jwst.extract_1d.extract - INFO - Working on slit 1479
2025-09-13 16:40:36,099 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:40:36,100 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 40.00 (inclusive)
2025-09-13 16:40:36,153 - jwst.extract_1d.extract - INFO - Working on slit 214
2025-09-13 16:40:36,154 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:40:36,155 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 104.00 (inclusive)
2025-09-13 16:40:36,209 - jwst.extract_1d.extract - INFO - Working on slit 693
2025-09-13 16:40:36,210 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:40:36,211 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 75.00 (inclusive)
2025-09-13 16:40:36,264 - jwst.extract_1d.extract - INFO - Working on slit 1120
2025-09-13 16:40:36,266 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:40:36,266 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 67.00 (inclusive)
2025-09-13 16:40:36,320 - jwst.extract_1d.extract - INFO - Working on slit 1257
2025-09-13 16:40:36,321 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:40:36,322 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 76.00 (inclusive)
2025-09-13 16:40:36,377 - jwst.extract_1d.extract - INFO - Working on slit 766
2025-09-13 16:40:36,378 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:40:36,379 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 103.00 (inclusive)
2025-09-13 16:40:36,433 - jwst.extract_1d.extract - INFO - Working on slit 606
2025-09-13 16:40:36,435 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type POINT
2025-09-13 16:40:36,435 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 10.00 (inclusive)
2025-09-13 16:40:36,442 - jwst.extract_1d.extract - INFO - Creating aperture correction.
2025-09-13 16:40:36,583 - jwst.extract_1d.extract - INFO - Working on slit 649
2025-09-13 16:40:36,584 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:40:36,585 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 94.00 (inclusive)
2025-09-13 16:40:36,641 - jwst.extract_1d.extract - INFO - Working on slit 982
2025-09-13 16:40:36,642 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:40:36,643 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 54.00 (inclusive)
2025-09-13 16:40:36,697 - jwst.extract_1d.extract - INFO - Working on slit 1364
2025-09-13 16:40:36,698 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:40:36,699 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 60.00 (inclusive)
2025-09-13 16:40:36,752 - jwst.extract_1d.extract - INFO - Working on slit 898
2025-09-13 16:40:36,753 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type POINT
2025-09-13 16:40:36,754 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 10.00 (inclusive)
2025-09-13 16:40:36,761 - jwst.extract_1d.extract - INFO - Creating aperture correction.
2025-09-13 16:40:36,889 - jwst.extract_1d.extract - INFO - Working on slit 1049
2025-09-13 16:40:36,890 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:40:36,891 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 76.00 (inclusive)
2025-09-13 16:40:36,946 - jwst.extract_1d.extract - INFO - Working on slit 732
2025-09-13 16:40:36,947 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:40:36,948 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 43.00 (inclusive)
2025-09-13 16:40:37,001 - jwst.extract_1d.extract - INFO - Working on slit 189
2025-09-13 16:40:37,002 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:40:37,003 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 47.00 (inclusive)
2025-09-13 16:40:37,056 - jwst.extract_1d.extract - INFO - Working on slit 881
2025-09-13 16:40:37,057 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type POINT
2025-09-13 16:40:37,057 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 10.00 (inclusive)
2025-09-13 16:40:37,064 - jwst.extract_1d.extract - INFO - Creating aperture correction.
2025-09-13 16:40:37,203 - jwst.extract_1d.extract - INFO - Working on slit 966
2025-09-13 16:40:37,204 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:40:37,205 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 59.00 (inclusive)
2025-09-13 16:40:37,259 - jwst.extract_1d.extract - INFO - Working on slit 914
2025-09-13 16:40:37,260 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:40:37,261 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 31.00 (inclusive)
2025-09-13 16:40:37,314 - jwst.extract_1d.extract - INFO - Working on slit 1084
2025-09-13 16:40:37,315 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type POINT
2025-09-13 16:40:37,316 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 10.00 (inclusive)
2025-09-13 16:40:37,323 - jwst.extract_1d.extract - INFO - Creating aperture correction.
2025-09-13 16:40:37,454 - jwst.extract_1d.extract - INFO - Working on slit 540
2025-09-13 16:40:37,455 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:40:37,456 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 71.00 (inclusive)
2025-09-13 16:40:37,510 - jwst.extract_1d.extract - INFO - Working on slit 1476
2025-09-13 16:40:37,511 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:40:37,511 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 42.00 (inclusive)
2025-09-13 16:40:37,566 - jwst.extract_1d.extract - INFO - Working on slit 1142
2025-09-13 16:40:37,567 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:40:37,568 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 45.00 (inclusive)
2025-09-13 16:40:37,621 - jwst.extract_1d.extract - INFO - Working on slit 220
2025-09-13 16:40:37,622 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type POINT
2025-09-13 16:40:37,623 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 10.00 (inclusive)
2025-09-13 16:40:37,629 - jwst.extract_1d.extract - INFO - Creating aperture correction.
2025-09-13 16:40:37,759 - jwst.extract_1d.extract - INFO - Working on slit 289
2025-09-13 16:40:37,760 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:40:37,761 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 36.00 (inclusive)
2025-09-13 16:40:37,816 - jwst.extract_1d.extract - INFO - Working on slit 934
2025-09-13 16:40:37,817 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:40:37,818 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 46.00 (inclusive)
2025-09-13 16:40:37,870 - jwst.extract_1d.extract - INFO - Working on slit 1219
2025-09-13 16:40:37,872 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:40:37,873 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 59.00 (inclusive)
2025-09-13 16:40:37,926 - jwst.extract_1d.extract - INFO - Working on slit 927
2025-09-13 16:40:37,927 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:40:37,928 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 43.00 (inclusive)
2025-09-13 16:40:37,980 - jwst.extract_1d.extract - INFO - Working on slit 1417
2025-09-13 16:40:37,981 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:40:37,982 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 38.00 (inclusive)
2025-09-13 16:40:38,035 - jwst.extract_1d.extract - INFO - Working on slit 567
2025-09-13 16:40:38,036 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:40:38,037 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 48.00 (inclusive)
2025-09-13 16:40:38,089 - jwst.extract_1d.extract - INFO - Working on slit 1296
2025-09-13 16:40:38,090 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:40:38,091 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 42.00 (inclusive)
2025-09-13 16:40:38,144 - jwst.extract_1d.extract - INFO - Working on slit 1412
2025-09-13 16:40:38,145 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:40:38,146 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 38.00 (inclusive)
2025-09-13 16:40:38,198 - jwst.extract_1d.extract - INFO - Working on slit 654
2025-09-13 16:40:38,199 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:40:38,200 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 59.00 (inclusive)
2025-09-13 16:40:38,251 - jwst.extract_1d.extract - INFO - Working on slit 1029
2025-09-13 16:40:38,252 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:40:38,253 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 56.00 (inclusive)
2025-09-13 16:40:38,305 - jwst.extract_1d.extract - INFO - Working on slit 553
2025-09-13 16:40:38,306 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:40:38,307 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 34.00 (inclusive)
2025-09-13 16:40:38,358 - jwst.extract_1d.extract - INFO - Working on slit 1387
2025-09-13 16:40:38,359 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:40:38,359 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 40.00 (inclusive)
2025-09-13 16:40:38,411 - jwst.extract_1d.extract - INFO - Working on slit 422
2025-09-13 16:40:38,412 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:40:38,413 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 28.00 (inclusive)
2025-09-13 16:40:38,464 - jwst.extract_1d.extract - INFO - Working on slit 821
2025-09-13 16:40:38,465 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:40:38,466 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 43.00 (inclusive)
2025-09-13 16:40:38,518 - jwst.extract_1d.extract - INFO - Working on slit 682
2025-09-13 16:40:38,519 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:40:38,520 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 49.00 (inclusive)
2025-09-13 16:40:38,571 - jwst.extract_1d.extract - INFO - Working on slit 1140
2025-09-13 16:40:38,572 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:40:38,573 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 41.00 (inclusive)
2025-09-13 16:40:38,625 - jwst.extract_1d.extract - INFO - Working on slit 1388
2025-09-13 16:40:38,627 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:40:38,627 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 58.00 (inclusive)
2025-09-13 16:40:38,679 - jwst.extract_1d.extract - INFO - Working on slit 759
2025-09-13 16:40:38,680 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:40:38,681 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 40.00 (inclusive)
2025-09-13 16:40:38,733 - jwst.extract_1d.extract - INFO - Working on slit 1407
2025-09-13 16:40:38,734 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:40:38,735 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 34.00 (inclusive)
2025-09-13 16:40:38,788 - jwst.extract_1d.extract - INFO - Working on slit 1194
2025-09-13 16:40:38,789 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:40:38,790 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 28.00 (inclusive)
2025-09-13 16:40:38,842 - jwst.extract_1d.extract - INFO - Working on slit 712
2025-09-13 16:40:38,843 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:40:38,844 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 34.00 (inclusive)
2025-09-13 16:40:38,896 - jwst.extract_1d.extract - INFO - Working on slit 539
2025-09-13 16:40:38,897 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:40:38,898 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 42.00 (inclusive)
2025-09-13 16:40:38,950 - jwst.extract_1d.extract - INFO - Working on slit 1008
2025-09-13 16:40:38,951 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:40:38,952 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 31.00 (inclusive)
2025-09-13 16:40:39,004 - jwst.extract_1d.extract - INFO - Working on slit 347
2025-09-13 16:40:39,005 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type POINT
2025-09-13 16:40:39,005 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 10.00 (inclusive)
2025-09-13 16:40:39,012 - jwst.extract_1d.extract - INFO - Creating aperture correction.
2025-09-13 16:40:39,136 - jwst.extract_1d.extract - INFO - Working on slit 276
2025-09-13 16:40:39,137 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:40:39,138 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 44.00 (inclusive)
2025-09-13 16:40:39,192 - jwst.extract_1d.extract - INFO - Working on slit 605
2025-09-13 16:40:39,193 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type POINT
2025-09-13 16:40:39,194 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 10.00 (inclusive)
2025-09-13 16:40:39,201 - jwst.extract_1d.extract - INFO - Creating aperture correction.
2025-09-13 16:40:39,319 - jwst.extract_1d.extract - INFO - Working on slit 922
2025-09-13 16:40:39,320 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:40:39,321 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 30.00 (inclusive)
2025-09-13 16:40:39,374 - jwst.extract_1d.extract - INFO - Working on slit 736
2025-09-13 16:40:39,375 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:40:39,376 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 22.00 (inclusive)
2025-09-13 16:40:39,430 - jwst.extract_1d.extract - INFO - Working on slit 1423
2025-09-13 16:40:39,431 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:40:39,432 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 31.00 (inclusive)
2025-09-13 16:40:39,484 - jwst.extract_1d.extract - INFO - Working on slit 800
2025-09-13 16:40:39,485 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:40:39,486 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 26.00 (inclusive)
2025-09-13 16:40:39,538 - jwst.extract_1d.extract - INFO - Working on slit 873
2025-09-13 16:40:39,539 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:40:39,539 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 27.00 (inclusive)
2025-09-13 16:40:39,593 - jwst.extract_1d.extract - INFO - Working on slit 385
2025-09-13 16:40:39,594 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:40:39,594 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 21.00 (inclusive)
2025-09-13 16:40:39,647 - jwst.extract_1d.extract - INFO - Working on slit 557
2025-09-13 16:40:39,648 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:40:39,649 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 37.00 (inclusive)
2025-09-13 16:40:39,700 - jwst.extract_1d.extract - INFO - Working on slit 719
2025-09-13 16:40:39,701 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:40:39,702 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 28.00 (inclusive)
2025-09-13 16:40:39,755 - jwst.extract_1d.extract - INFO - Working on slit 389
2025-09-13 16:40:39,756 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:40:39,757 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 30.00 (inclusive)
2025-09-13 16:40:39,809 - jwst.extract_1d.extract - INFO - Working on slit 733
2025-09-13 16:40:39,810 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:40:39,811 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 44.00 (inclusive)
2025-09-13 16:40:39,863 - jwst.extract_1d.extract - INFO - Working on slit 1442
2025-09-13 16:40:39,864 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:40:39,865 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 44.00 (inclusive)
2025-09-13 16:40:39,917 - jwst.extract_1d.extract - INFO - Working on slit 417
2025-09-13 16:40:39,918 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:40:39,919 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 28.00 (inclusive)
2025-09-13 16:40:39,970 - jwst.extract_1d.extract - INFO - Working on slit 630
2025-09-13 16:40:39,971 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type POINT
2025-09-13 16:40:39,972 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 10.00 (inclusive)
2025-09-13 16:40:39,979 - jwst.extract_1d.extract - INFO - Creating aperture correction.
2025-09-13 16:40:40,096 - jwst.extract_1d.extract - INFO - Working on slit 925
2025-09-13 16:40:40,097 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:40:40,098 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 32.00 (inclusive)
2025-09-13 16:40:40,150 - jwst.extract_1d.extract - INFO - Working on slit 527
2025-09-13 16:40:40,152 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:40:40,152 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 35.00 (inclusive)
2025-09-13 16:40:40,206 - jwst.extract_1d.extract - INFO - Working on slit 439
2025-09-13 16:40:40,207 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type POINT
2025-09-13 16:40:40,207 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 10.00 (inclusive)
2025-09-13 16:40:40,214 - jwst.extract_1d.extract - INFO - Creating aperture correction.
2025-09-13 16:40:40,339 - jwst.extract_1d.extract - INFO - Working on slit 1253
2025-09-13 16:40:40,340 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:40:40,341 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 33.00 (inclusive)
2025-09-13 16:40:40,393 - jwst.extract_1d.extract - INFO - Working on slit 1162
2025-09-13 16:40:40,394 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:40:40,395 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 18.00 (inclusive)
2025-09-13 16:40:40,447 - jwst.extract_1d.extract - INFO - Working on slit 1457
2025-09-13 16:40:40,448 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:40:40,450 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 24.00 (inclusive)
2025-09-13 16:40:40,502 - jwst.extract_1d.extract - INFO - Working on slit 694
2025-09-13 16:40:40,504 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:40:40,505 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 21.00 (inclusive)
2025-09-13 16:40:40,557 - jwst.extract_1d.extract - INFO - Working on slit 1266
2025-09-13 16:40:40,558 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:40:40,559 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 26.00 (inclusive)
2025-09-13 16:40:40,612 - jwst.extract_1d.extract - INFO - Working on slit 298
2025-09-13 16:40:40,613 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:40:40,614 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 23.00 (inclusive)
2025-09-13 16:40:40,667 - jwst.extract_1d.extract - INFO - Working on slit 516
2025-09-13 16:40:40,668 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:40:40,669 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 33.00 (inclusive)
2025-09-13 16:40:40,721 - jwst.extract_1d.extract - INFO - Working on slit 973
2025-09-13 16:40:40,722 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:40:40,723 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 20.00 (inclusive)
2025-09-13 16:40:40,777 - jwst.extract_1d.extract - INFO - Working on slit 180
2025-09-13 16:40:40,779 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:40:40,780 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 32.00 (inclusive)
2025-09-13 16:40:40,832 - jwst.extract_1d.extract - INFO - Working on slit 980
2025-09-13 16:40:40,833 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:40:40,834 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 29.00 (inclusive)
2025-09-13 16:40:40,887 - jwst.extract_1d.extract - INFO - Working on slit 263
2025-09-13 16:40:40,888 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:40:40,889 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 24.00 (inclusive)
2025-09-13 16:40:40,941 - jwst.extract_1d.extract - INFO - Working on slit 493
2025-09-13 16:40:40,942 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:40:40,943 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 30.00 (inclusive)
2025-09-13 16:40:40,998 - jwst.extract_1d.extract - INFO - Working on slit 981
2025-09-13 16:40:40,999 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:40:41,000 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 23.00 (inclusive)
2025-09-13 16:40:41,053 - jwst.extract_1d.extract - INFO - Working on slit 1371
2025-09-13 16:40:41,054 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:40:41,055 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 22.00 (inclusive)
2025-09-13 16:40:41,109 - jwst.extract_1d.extract - INFO - Working on slit 536
2025-09-13 16:40:41,110 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:40:41,111 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 34.00 (inclusive)
2025-09-13 16:40:41,164 - jwst.extract_1d.extract - INFO - Working on slit 749
2025-09-13 16:40:41,165 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:40:41,166 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 22.00 (inclusive)
2025-09-13 16:40:41,219 - jwst.extract_1d.extract - INFO - Working on slit 345
2025-09-13 16:40:41,220 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:40:41,221 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 21.00 (inclusive)
2025-09-13 16:40:41,275 - jwst.extract_1d.extract - INFO - Working on slit 721
2025-09-13 16:40:41,276 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type POINT
2025-09-13 16:40:41,277 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 10.00 (inclusive)
2025-09-13 16:40:41,284 - jwst.extract_1d.extract - INFO - Creating aperture correction.
2025-09-13 16:40:41,399 - jwst.extract_1d.extract - INFO - Working on slit 387
2025-09-13 16:40:41,400 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:40:41,401 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 18.00 (inclusive)
2025-09-13 16:40:41,456 - jwst.extract_1d.extract - INFO - Working on slit 505
2025-09-13 16:40:41,457 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:40:41,458 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 21.00 (inclusive)
2025-09-13 16:40:41,512 - jwst.extract_1d.extract - INFO - Working on slit 566
2025-09-13 16:40:41,513 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:40:41,514 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 35.00 (inclusive)
2025-09-13 16:40:41,567 - jwst.extract_1d.extract - INFO - Working on slit 772
2025-09-13 16:40:41,568 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:40:41,569 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 25.00 (inclusive)
2025-09-13 16:40:41,623 - jwst.extract_1d.extract - INFO - Working on slit 722
2025-09-13 16:40:41,625 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:40:41,626 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 26.00 (inclusive)
2025-09-13 16:40:41,679 - jwst.extract_1d.extract - INFO - Working on slit 872
2025-09-13 16:40:41,680 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type POINT
2025-09-13 16:40:41,681 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 10.00 (inclusive)
2025-09-13 16:40:41,688 - jwst.extract_1d.extract - INFO - Creating aperture correction.
2025-09-13 16:40:41,807 - jwst.extract_1d.extract - INFO - Working on slit 933
2025-09-13 16:40:41,808 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:40:41,809 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 24.00 (inclusive)
2025-09-13 16:40:41,862 - jwst.extract_1d.extract - INFO - Working on slit 1128
2025-09-13 16:40:41,863 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type POINT
2025-09-13 16:40:41,864 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 10.00 (inclusive)
2025-09-13 16:40:41,871 - jwst.extract_1d.extract - INFO - Creating aperture correction.
2025-09-13 16:40:41,983 - jwst.extract_1d.extract - INFO - Working on slit 1282
2025-09-13 16:40:41,984 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:40:41,985 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 35.00 (inclusive)
2025-09-13 16:40:42,036 - jwst.extract_1d.extract - INFO - Working on slit 274
2025-09-13 16:40:42,037 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:40:42,038 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 31.00 (inclusive)
2025-09-13 16:40:42,090 - jwst.extract_1d.extract - INFO - Working on slit 641
2025-09-13 16:40:42,091 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:40:42,092 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 23.00 (inclusive)
2025-09-13 16:40:42,144 - jwst.extract_1d.extract - INFO - Working on slit 543
2025-09-13 16:40:42,145 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:40:42,146 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 29.00 (inclusive)
2025-09-13 16:40:42,198 - jwst.extract_1d.extract - INFO - Working on slit 610
2025-09-13 16:40:42,198 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type POINT
2025-09-13 16:40:42,199 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 10.00 (inclusive)
2025-09-13 16:40:42,206 - jwst.extract_1d.extract - INFO - Creating aperture correction.
2025-09-13 16:40:42,264 - jwst.extract_1d.extract - INFO - Working on slit 1188
2025-09-13 16:40:42,265 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:40:42,266 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 37.00 (inclusive)
2025-09-13 16:40:42,317 - jwst.extract_1d.extract - INFO - Working on slit 533
2025-09-13 16:40:42,318 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:40:42,319 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 21.00 (inclusive)
2025-09-13 16:40:42,370 - jwst.extract_1d.extract - INFO - Working on slit 1342
2025-09-13 16:40:42,371 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:40:42,372 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 22.00 (inclusive)
2025-09-13 16:40:42,687 - stpipe.Spec2Pipeline.extract_1d - INFO - Saved model in /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage2_spec/jw02079004003_05101_00001_nis_x1d.fits
2025-09-13 16:40:42,688 - stpipe.Spec2Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 16:40:42,690 - stpipe.Spec2Pipeline - INFO - Finished processing product /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage1/jw02079004003_05101_00001_nis
2025-09-13 16:40:42,693 - stpipe.Spec2Pipeline - INFO - Ending calwebb_spec2
2025-09-13 16:40:42,694 - jwst.stpipe.core - INFO - Results used CRDS context: jwst_1413.pmap
2025-09-13 16:40:53,992 - stpipe.Spec2Pipeline - INFO - Saved model in /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage2_spec/jw02079004003_05101_00001_nis_cal.fits
2025-09-13 16:40:53,992 - stpipe.Spec2Pipeline - INFO - Step Spec2Pipeline done
2025-09-13 16:40:53,993 - jwst.stpipe.core - INFO - Results used jwst version: 1.19.1
2025-09-13 16:40:54,005 - py.warnings - WARNING - /usr/share/miniconda/lib/python3.13/site-packages/jwst/associations/association.py:234: UserWarning: Input association file contains path information; note that this can complicate usage and/or sharing of such files.
warnings.warn(err_str, UserWarning, stacklevel=1)
2025-09-13 16:40:54,061 - stpipe - INFO - PARS-SPEC2PIPELINE parameters found: /home/runner/crds/references/jwst/niriss/jwst_niriss_pars-spec2pipeline_0005.asdf
2025-09-13 16:40:54,082 - stpipe.Spec2Pipeline - INFO - Spec2Pipeline instance created.
2025-09-13 16:40:54,083 - stpipe.Spec2Pipeline.assign_wcs - INFO - AssignWcsStep instance created.
2025-09-13 16:40:54,084 - stpipe.Spec2Pipeline.badpix_selfcal - INFO - BadpixSelfcalStep instance created.
2025-09-13 16:40:54,085 - stpipe.Spec2Pipeline.msa_flagging - INFO - MSAFlagOpenStep instance created.
2025-09-13 16:40:54,086 - stpipe.Spec2Pipeline.nsclean - INFO - NSCleanStep instance created.
2025-09-13 16:40:54,087 - stpipe.Spec2Pipeline.bkg_subtract - INFO - BackgroundStep instance created.
2025-09-13 16:40:54,088 - stpipe.Spec2Pipeline.imprint_subtract - INFO - ImprintStep instance created.
2025-09-13 16:40:54,089 - stpipe.Spec2Pipeline.extract_2d - INFO - Extract2dStep instance created.
2025-09-13 16:40:54,093 - stpipe.Spec2Pipeline.master_background_mos - INFO - MasterBackgroundMosStep instance created.
2025-09-13 16:40:54,094 - stpipe.Spec2Pipeline.master_background_mos.flat_field - INFO - FlatFieldStep instance created.
2025-09-13 16:40:54,095 - stpipe.Spec2Pipeline.master_background_mos.pathloss - INFO - PathLossStep instance created.
2025-09-13 16:40:54,096 - stpipe.Spec2Pipeline.master_background_mos.barshadow - INFO - BarShadowStep instance created.
2025-09-13 16:40:54,097 - stpipe.Spec2Pipeline.master_background_mos.photom - INFO - PhotomStep instance created.
2025-09-13 16:40:54,097 - stpipe.Spec2Pipeline.master_background_mos.pixel_replace - INFO - PixelReplaceStep instance created.
2025-09-13 16:40:54,098 - stpipe.Spec2Pipeline.master_background_mos.resample_spec - INFO - ResampleSpecStep instance created.
2025-09-13 16:40:54,100 - stpipe.Spec2Pipeline.master_background_mos.extract_1d - INFO - Extract1dStep instance created.
2025-09-13 16:40:54,101 - stpipe.Spec2Pipeline.wavecorr - INFO - WavecorrStep instance created.
2025-09-13 16:40:54,101 - stpipe.Spec2Pipeline.flat_field - INFO - FlatFieldStep instance created.
2025-09-13 16:40:54,103 - stpipe.Spec2Pipeline.srctype - INFO - SourceTypeStep instance created.
2025-09-13 16:40:54,104 - stpipe.Spec2Pipeline.straylight - INFO - StraylightStep instance created.
2025-09-13 16:40:54,104 - stpipe.Spec2Pipeline.fringe - INFO - FringeStep instance created.
2025-09-13 16:40:54,106 - stpipe.Spec2Pipeline.residual_fringe - INFO - ResidualFringeStep instance created.
2025-09-13 16:40:54,107 - stpipe.Spec2Pipeline.pathloss - INFO - PathLossStep instance created.
2025-09-13 16:40:54,107 - stpipe.Spec2Pipeline.barshadow - INFO - BarShadowStep instance created.
2025-09-13 16:40:54,108 - stpipe.Spec2Pipeline.wfss_contam - INFO - WfssContamStep instance created.
2025-09-13 16:40:54,109 - stpipe.Spec2Pipeline.photom - INFO - PhotomStep instance created.
2025-09-13 16:40:54,110 - stpipe.Spec2Pipeline.pixel_replace - INFO - PixelReplaceStep instance created.
2025-09-13 16:40:54,111 - stpipe.Spec2Pipeline.resample_spec - INFO - ResampleSpecStep instance created.
2025-09-13 16:40:54,112 - stpipe.Spec2Pipeline.cube_build - INFO - CubeBuildStep instance created.
2025-09-13 16:40:54,114 - stpipe.Spec2Pipeline.extract_1d - INFO - Extract1dStep instance created.
2025-09-13 16:40:54,708 - stpipe.Spec2Pipeline - INFO - Step Spec2Pipeline running with args ('/home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/jw02079004003_05101_00002_nis_spec2_asn.json',).
2025-09-13 16:40:54,742 - stpipe.Spec2Pipeline - INFO - Step Spec2Pipeline parameters are:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage2_spec
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: True
skip: False
suffix: None
search_output_file: True
input_dir: ''
save_bsub: False
fail_on_exception: True
save_wfss_esec: False
steps:
assign_wcs:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
sip_approx: True
sip_max_pix_error: 0.01
sip_degree: None
sip_max_inv_pix_error: 0.01
sip_inv_degree: None
sip_npoints: 12
slit_y_low: -0.55
slit_y_high: 0.55
nrs_ifu_slice_wcs: False
badpix_selfcal:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: True
suffix: None
search_output_file: True
input_dir: ''
flagfrac_lower: 0.001
flagfrac_upper: 0.001
kernel_size: 15
force_single: False
save_flagged_bkg: False
msa_flagging:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
nsclean:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: True
suffix: None
search_output_file: True
input_dir: ''
fit_method: fft
fit_by_channel: False
background_method: None
background_box_size: None
mask_spectral_regions: True
n_sigma: 5.0
fit_histogram: False
single_mask: False
user_mask: None
save_mask: False
save_background: False
save_noise: False
bkg_subtract:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
bkg_list: None
save_combined_background: False
sigma: 3.0
maxiters: None
soss_source_percentile: 35.0
soss_bkg_percentile: None
wfss_mmag_extract: None
wfss_maxiter: 5
wfss_rms_stop: 0.0
wfss_outlier_percent: 1.0
imprint_subtract:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
extract_2d:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
slit_names: None
source_ids: None
extract_orders: None
grism_objects: None
tsgrism_extract_height: None
wfss_extract_half_height: 5
wfss_mmag_extract: None
wfss_nbright: 100
master_background_mos:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: True
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
sigma_clip: 3.0
median_kernel: 1
force_subtract: False
save_background: False
user_background: None
inverse: False
steps:
flat_field:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
save_interpolated_flat: False
user_supplied_flat: None
inverse: False
pathloss:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
inverse: False
source_type: None
user_slit_loc: None
barshadow:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
inverse: False
source_type: None
photom:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
inverse: False
source_type: None
mrs_time_correction: True
pixel_replace:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: True
output_use_index: True
save_results: False
skip: True
suffix: None
search_output_file: True
input_dir: ''
algorithm: fit_profile
n_adjacent_cols: 3
resample_spec:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
pixfrac: 1.0
kernel: square
fillval: NAN
weight_type: ivm
output_shape: None
pixel_scale_ratio: 1.0
pixel_scale: None
output_wcs: ''
single: False
blendheaders: True
in_memory: True
extract_1d:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
subtract_background: None
apply_apcorr: True
extraction_type: box
use_source_posn: None
position_offset: 0.0
model_nod_pair: True
optimize_psf_location: True
smoothing_length: None
bkg_fit: None
bkg_order: None
log_increment: 50
save_profile: False
save_scene_model: False
save_residual_image: False
center_xy: None
ifu_autocen: False
bkg_sigma_clip: 3.0
ifu_rfcorr: True
ifu_set_srctype: None
ifu_rscale: None
ifu_covar_scale: 1.0
soss_atoca: True
soss_threshold: 0.01
soss_n_os: 2
soss_wave_grid_in: None
soss_wave_grid_out: None
soss_estimate: None
soss_rtol: 0.0001
soss_max_grid_size: 20000
soss_tikfac: None
soss_width: 40.0
soss_bad_pix: masking
soss_modelname: None
wavecorr:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
flat_field:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
save_interpolated_flat: False
user_supplied_flat: None
inverse: False
srctype:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
source_type: None
straylight:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
clean_showers: False
shower_plane: 3
shower_x_stddev: 18.0
shower_y_stddev: 5.0
shower_low_reject: 0.1
shower_high_reject: 99.9
save_shower_model: False
fringe:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
residual_fringe:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: True
suffix: residual_fringe
search_output_file: False
input_dir: ''
save_intermediate_results: False
ignore_region_min: None
ignore_region_max: None
pathloss:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
inverse: False
source_type: None
user_slit_loc: None
barshadow:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
inverse: False
source_type: None
wfss_contam:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: True
suffix: None
search_output_file: True
input_dir: ''
save_simulated_image: False
save_contam_images: False
maximum_cores: none
photom:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
inverse: False
source_type: None
mrs_time_correction: True
pixel_replace:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: True
output_use_index: True
save_results: False
skip: True
suffix: None
search_output_file: True
input_dir: ''
algorithm: fit_profile
n_adjacent_cols: 3
resample_spec:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
pixfrac: 1.0
kernel: square
fillval: NAN
weight_type: ivm
output_shape: None
pixel_scale_ratio: 1.0
pixel_scale: None
output_wcs: ''
single: False
blendheaders: True
in_memory: True
cube_build:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: True
output_use_index: True
save_results: False
skip: False
suffix: s3d
search_output_file: False
input_dir: ''
channel: all
band: all
grating: all
filter: all
output_type: None
scalexy: 0.0
scalew: 0.0
weighting: drizzle
coord_system: skyalign
ra_center: None
dec_center: None
cube_pa: None
nspax_x: None
nspax_y: None
rois: 0.0
roiw: 0.0
weight_power: 2.0
wavemin: None
wavemax: None
single: False
skip_dqflagging: False
offset_file: None
debug_spaxel: -1 -1 -1
extract_1d:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
subtract_background: None
apply_apcorr: True
extraction_type: box
use_source_posn: None
position_offset: 0.0
model_nod_pair: True
optimize_psf_location: True
smoothing_length: None
bkg_fit: None
bkg_order: None
log_increment: 50
save_profile: False
save_scene_model: False
save_residual_image: False
center_xy: None
ifu_autocen: False
bkg_sigma_clip: 3.0
ifu_rfcorr: True
ifu_set_srctype: None
ifu_rscale: None
ifu_covar_scale: 1.0
soss_atoca: True
soss_threshold: 0.01
soss_n_os: 2
soss_wave_grid_in: None
soss_wave_grid_out: None
soss_estimate: None
soss_rtol: 0.0001
soss_max_grid_size: 20000
soss_tikfac: None
soss_width: 40.0
soss_bad_pix: masking
soss_modelname: None
2025-09-13 16:40:54,790 - stpipe.Spec2Pipeline - INFO - Prefetching reference files for dataset: 'jw02079004003_05101_00002_nis_spec2_asn.json' reftypes = ['apcorr', 'area', 'barshadow', 'bkg', 'camera', 'collimator', 'cubepar', 'dflat', 'disperser', 'distortion', 'extract1d', 'fflat', 'filteroffset', 'flat', 'fore', 'fpa', 'fringe', 'ifufore', 'ifupost', 'ifuslicer', 'mrsxartcorr', 'msa', 'msaoper', 'ote', 'pastasoss', 'pathloss', 'photom', 'psf', 'regions', 'sflat', 'speckernel', 'specprofile', 'specwcs', 'wavecorr', 'wavelengthrange']
2025-09-13 16:40:54,793 - stpipe.Spec2Pipeline - INFO - Prefetch for APCORR reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits'.
2025-09-13 16:40:54,794 - stpipe.Spec2Pipeline - INFO - Prefetch for AREA reference file is 'N/A'.
2025-09-13 16:40:54,794 - stpipe.Spec2Pipeline - INFO - Prefetch for BARSHADOW reference file is 'N/A'.
2025-09-13 16:40:54,795 - stpipe.Spec2Pipeline - INFO - Prefetch for BKG reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_bkg_0027.fits'.
2025-09-13 16:40:54,795 - stpipe.Spec2Pipeline - INFO - Prefetch for CAMERA reference file is 'N/A'.
2025-09-13 16:40:54,795 - stpipe.Spec2Pipeline - INFO - Prefetch for COLLIMATOR reference file is 'N/A'.
2025-09-13 16:40:54,796 - stpipe.Spec2Pipeline - INFO - Prefetch for CUBEPAR reference file is 'N/A'.
2025-09-13 16:40:54,796 - stpipe.Spec2Pipeline - INFO - Prefetch for DFLAT reference file is 'N/A'.
2025-09-13 16:40:54,797 - stpipe.Spec2Pipeline - INFO - Prefetch for DISPERSER reference file is 'N/A'.
2025-09-13 16:40:54,797 - stpipe.Spec2Pipeline - INFO - Prefetch for DISTORTION reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_distortion_0037.asdf'.
2025-09-13 16:40:54,797 - stpipe.Spec2Pipeline - INFO - Prefetch for EXTRACT1D reference file is 'N/A'.
2025-09-13 16:40:54,798 - stpipe.Spec2Pipeline - INFO - Prefetch for FFLAT reference file is 'N/A'.
2025-09-13 16:40:54,798 - stpipe.Spec2Pipeline - INFO - Prefetch for FILTEROFFSET reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_filteroffset_0006.asdf'.
2025-09-13 16:40:54,799 - stpipe.Spec2Pipeline - INFO - Prefetch for FLAT reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_flat_0265.fits'.
2025-09-13 16:40:54,799 - stpipe.Spec2Pipeline - INFO - Prefetch for FORE reference file is 'N/A'.
2025-09-13 16:40:54,799 - stpipe.Spec2Pipeline - INFO - Prefetch for FPA reference file is 'N/A'.
2025-09-13 16:40:54,800 - stpipe.Spec2Pipeline - INFO - Prefetch for FRINGE reference file is 'N/A'.
2025-09-13 16:40:54,800 - stpipe.Spec2Pipeline - INFO - Prefetch for IFUFORE reference file is 'N/A'.
2025-09-13 16:40:54,801 - stpipe.Spec2Pipeline - INFO - Prefetch for IFUPOST reference file is 'N/A'.
2025-09-13 16:40:54,801 - stpipe.Spec2Pipeline - INFO - Prefetch for IFUSLICER reference file is 'N/A'.
2025-09-13 16:40:54,801 - stpipe.Spec2Pipeline - INFO - Prefetch for MRSXARTCORR reference file is 'N/A'.
2025-09-13 16:40:54,802 - stpipe.Spec2Pipeline - INFO - Prefetch for MSA reference file is 'N/A'.
2025-09-13 16:40:54,802 - stpipe.Spec2Pipeline - INFO - Prefetch for MSAOPER reference file is 'N/A'.
2025-09-13 16:40:54,802 - stpipe.Spec2Pipeline - INFO - Prefetch for OTE reference file is 'N/A'.
2025-09-13 16:40:54,803 - stpipe.Spec2Pipeline - INFO - Prefetch for PASTASOSS reference file is 'N/A'.
2025-09-13 16:40:54,803 - stpipe.Spec2Pipeline - INFO - Prefetch for PATHLOSS reference file is 'N/A'.
2025-09-13 16:40:54,804 - stpipe.Spec2Pipeline - INFO - Prefetch for PHOTOM reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_photom_0041.fits'.
2025-09-13 16:40:54,804 - stpipe.Spec2Pipeline - INFO - Prefetch for PSF reference file is 'N/A'.
2025-09-13 16:40:54,804 - stpipe.Spec2Pipeline - INFO - Prefetch for REGIONS reference file is 'N/A'.
2025-09-13 16:40:54,805 - stpipe.Spec2Pipeline - INFO - Prefetch for SFLAT reference file is 'N/A'.
2025-09-13 16:40:54,805 - stpipe.Spec2Pipeline - INFO - Prefetch for SPECKERNEL reference file is 'N/A'.
2025-09-13 16:40:54,806 - stpipe.Spec2Pipeline - INFO - Prefetch for SPECPROFILE reference file is 'N/A'.
2025-09-13 16:40:54,806 - stpipe.Spec2Pipeline - INFO - Prefetch for SPECWCS reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_specwcs_0064.asdf'.
2025-09-13 16:40:54,807 - stpipe.Spec2Pipeline - INFO - Prefetch for WAVECORR reference file is 'N/A'.
2025-09-13 16:40:54,807 - stpipe.Spec2Pipeline - INFO - Prefetch for WAVELENGTHRANGE reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_wavelengthrange_0002.asdf'.
2025-09-13 16:40:54,807 - stpipe.Spec2Pipeline - INFO - Starting calwebb_spec2 ...
2025-09-13 16:40:54,814 - stpipe.Spec2Pipeline - INFO - Processing product /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage1/jw02079004003_05101_00002_nis
2025-09-13 16:40:54,814 - stpipe.Spec2Pipeline - INFO - Working on input /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage1/jw02079004003_05101_00002_nis_rate.fits ...
2025-09-13 16:40:54,862 - stpipe.Spec2Pipeline - INFO - Using sourcecat file jw02079-o004_niriss_clear-f200w_cat.ecsv
2025-09-13 16:40:54,863 - stpipe.Spec2Pipeline - INFO - Using segmentation map jw02079-o004_niriss_clear-f200w_segm.fits
2025-09-13 16:40:54,864 - stpipe.Spec2Pipeline - INFO - Using direct image jw02079-o004_niriss_clear-f200w_i2d.fits
2025-09-13 16:40:55,260 - stpipe.Spec2Pipeline.assign_wcs - INFO - Step assign_wcs running with args (<ImageModel(2048, 2048) from jw02079004003_05101_00002_nis_rate.fits>,).
2025-09-13 16:40:55,376 - jwst.assign_wcs.niriss - INFO - Added Barycentric velocity correction: 0.9999282763888806
2025-09-13 16:40:55,432 - jwst.assign_wcs.niriss - INFO - Offsets from filteroffset file are 2.119, -1.0476
2025-09-13 16:40:55,511 - jwst.assign_wcs.assign_wcs - INFO - COMPLETED assign_wcs
2025-09-13 16:40:55,513 - stpipe.AssignWcsStep - INFO - AssignWcsStep instance created.
2025-09-13 16:40:55,590 - jwst.assign_wcs.niriss - INFO - Offsets from filteroffset file are 2.119, -1.0476
2025-09-13 16:40:55,639 - stpipe.Spec2Pipeline.assign_wcs - INFO - Step assign_wcs done
2025-09-13 16:40:56,052 - stpipe.Spec2Pipeline.badpix_selfcal - INFO - Step badpix_selfcal running with args (<ImageModel(2048, 2048) from jw02079004003_05101_00002_nis_rate.fits>, [], []).
2025-09-13 16:40:56,053 - stpipe.Spec2Pipeline.badpix_selfcal - INFO - Step skipped.
2025-09-13 16:40:56,459 - stpipe.Spec2Pipeline.msa_flagging - INFO - Step msa_flagging running with args (<ImageModel(2048, 2048) from jw02079004003_05101_00002_nis_rate.fits>,).
2025-09-13 16:40:56,460 - stpipe.Spec2Pipeline.msa_flagging - INFO - Step skipped.
2025-09-13 16:40:56,858 - stpipe.Spec2Pipeline.nsclean - INFO - Step nsclean running with args (<ImageModel(2048, 2048) from jw02079004003_05101_00002_nis_rate.fits>,).
2025-09-13 16:40:56,859 - stpipe.Spec2Pipeline.nsclean - INFO - Step skipped.
2025-09-13 16:40:57,263 - stpipe.Spec2Pipeline.imprint_subtract - INFO - Step imprint_subtract running with args (<ImageModel(2048, 2048) from jw02079004003_05101_00002_nis_rate.fits>, []).
2025-09-13 16:40:57,264 - stpipe.Spec2Pipeline.imprint_subtract - INFO - Step skipped.
2025-09-13 16:40:57,651 - stpipe.Spec2Pipeline.bkg_subtract - INFO - Step bkg_subtract running with args (<ImageModel(2048, 2048) from jw02079004003_05101_00002_nis_rate.fits>, []).
2025-09-13 16:40:57,916 - jwst.background.asn_intake - INFO - Working on input <ImageModel(2048, 2048) from jw02079004003_05101_00002_nis_rate.fits> ...
2025-09-13 16:40:58,192 - stpipe.Spec2Pipeline.bkg_subtract - INFO - Using BKG reference file /home/runner/crds/references/jwst/niriss/jwst_niriss_bkg_0027.fits
2025-09-13 16:40:58,193 - stpipe.Spec2Pipeline.bkg_subtract - INFO - Using WavelengthRange reference file /home/runner/crds/references/jwst/niriss/jwst_niriss_wavelengthrange_0002.asdf
2025-09-13 16:40:58,258 - jwst.assign_wcs.util - INFO - Getting objects from jw02079-o004_niriss_clear-f200w_cat.ecsv
2025-09-13 16:40:58,547 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1, order 1
2025-09-13 16:40:58,560 - jwst.assign_wcs.util - INFO - Excluding off-image object: 2, order 1
2025-09-13 16:40:58,572 - jwst.assign_wcs.util - INFO - Excluding off-image object: 3, order 1
2025-09-13 16:40:58,584 - jwst.assign_wcs.util - INFO - Excluding off-image object: 4, order 1
2025-09-13 16:40:58,596 - jwst.assign_wcs.util - INFO - Excluding off-image object: 5, order 1
2025-09-13 16:40:58,609 - jwst.assign_wcs.util - INFO - Excluding off-image object: 6, order 1
2025-09-13 16:40:58,621 - jwst.assign_wcs.util - INFO - Excluding off-image object: 7, order 1
2025-09-13 16:40:58,633 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 8 order: 1
2025-09-13 16:40:58,646 - jwst.assign_wcs.util - INFO - Excluding off-image object: 9, order 1
2025-09-13 16:40:58,658 - jwst.assign_wcs.util - INFO - Excluding off-image object: 10, order 1
2025-09-13 16:40:58,670 - jwst.assign_wcs.util - INFO - Excluding off-image object: 11, order 1
2025-09-13 16:40:58,682 - jwst.assign_wcs.util - INFO - Excluding off-image object: 12, order 1
2025-09-13 16:40:58,694 - jwst.assign_wcs.util - INFO - Excluding off-image object: 13, order 1
2025-09-13 16:40:58,707 - jwst.assign_wcs.util - INFO - Excluding off-image object: 14, order 1
2025-09-13 16:40:58,719 - jwst.assign_wcs.util - INFO - Excluding off-image object: 15, order 1
2025-09-13 16:40:58,731 - jwst.assign_wcs.util - INFO - Excluding off-image object: 16, order 1
2025-09-13 16:40:58,743 - jwst.assign_wcs.util - INFO - Excluding off-image object: 17, order 1
2025-09-13 16:40:58,755 - jwst.assign_wcs.util - INFO - Excluding off-image object: 18, order 1
2025-09-13 16:40:58,768 - jwst.assign_wcs.util - INFO - Excluding off-image object: 19, order 1
2025-09-13 16:40:58,780 - jwst.assign_wcs.util - INFO - Excluding off-image object: 20, order 1
2025-09-13 16:40:58,792 - jwst.assign_wcs.util - INFO - Excluding off-image object: 21, order 1
2025-09-13 16:40:58,804 - jwst.assign_wcs.util - INFO - Excluding off-image object: 22, order 1
2025-09-13 16:40:58,816 - jwst.assign_wcs.util - INFO - Excluding off-image object: 23, order 1
2025-09-13 16:40:58,828 - jwst.assign_wcs.util - INFO - Excluding off-image object: 24, order 1
2025-09-13 16:40:58,840 - jwst.assign_wcs.util - INFO - Excluding off-image object: 25, order 1
2025-09-13 16:40:58,852 - jwst.assign_wcs.util - INFO - Excluding off-image object: 26, order 1
2025-09-13 16:40:58,864 - jwst.assign_wcs.util - INFO - Excluding off-image object: 27, order 1
2025-09-13 16:40:58,876 - jwst.assign_wcs.util - INFO - Excluding off-image object: 28, order 1
2025-09-13 16:40:58,888 - jwst.assign_wcs.util - INFO - Excluding off-image object: 29, order 1
2025-09-13 16:40:58,901 - jwst.assign_wcs.util - INFO - Excluding off-image object: 30, order 1
2025-09-13 16:40:58,914 - jwst.assign_wcs.util - INFO - Excluding off-image object: 31, order 1
2025-09-13 16:40:58,927 - jwst.assign_wcs.util - INFO - Excluding off-image object: 32, order 1
2025-09-13 16:40:58,939 - jwst.assign_wcs.util - INFO - Excluding off-image object: 33, order 1
2025-09-13 16:40:58,951 - jwst.assign_wcs.util - INFO - Excluding off-image object: 34, order 1
2025-09-13 16:40:58,963 - jwst.assign_wcs.util - INFO - Excluding off-image object: 35, order 1
2025-09-13 16:40:58,975 - jwst.assign_wcs.util - INFO - Excluding off-image object: 36, order 1
2025-09-13 16:40:58,987 - jwst.assign_wcs.util - INFO - Excluding off-image object: 37, order 1
2025-09-13 16:40:59,000 - jwst.assign_wcs.util - INFO - Excluding off-image object: 38, order 1
2025-09-13 16:40:59,012 - jwst.assign_wcs.util - INFO - Excluding off-image object: 39, order 1
2025-09-13 16:40:59,024 - jwst.assign_wcs.util - INFO - Excluding off-image object: 40, order 1
2025-09-13 16:40:59,036 - jwst.assign_wcs.util - INFO - Excluding off-image object: 41, order 1
2025-09-13 16:40:59,048 - jwst.assign_wcs.util - INFO - Excluding off-image object: 42, order 1
2025-09-13 16:40:59,060 - jwst.assign_wcs.util - INFO - Excluding off-image object: 43, order 1
2025-09-13 16:40:59,072 - jwst.assign_wcs.util - INFO - Excluding off-image object: 44, order 1
2025-09-13 16:40:59,084 - jwst.assign_wcs.util - INFO - Excluding off-image object: 45, order 1
2025-09-13 16:40:59,096 - jwst.assign_wcs.util - INFO - Excluding off-image object: 46, order 1
2025-09-13 16:40:59,108 - jwst.assign_wcs.util - INFO - Excluding off-image object: 47, order 1
2025-09-13 16:40:59,121 - jwst.assign_wcs.util - INFO - Excluding off-image object: 48, order 1
2025-09-13 16:40:59,134 - jwst.assign_wcs.util - INFO - Excluding off-image object: 49, order 1
2025-09-13 16:40:59,146 - jwst.assign_wcs.util - INFO - Excluding off-image object: 50, order 1
2025-09-13 16:40:59,158 - jwst.assign_wcs.util - INFO - Excluding off-image object: 51, order 1
2025-09-13 16:40:59,171 - jwst.assign_wcs.util - INFO - Excluding off-image object: 52, order 1
2025-09-13 16:40:59,183 - jwst.assign_wcs.util - INFO - Excluding off-image object: 53, order 1
2025-09-13 16:40:59,195 - jwst.assign_wcs.util - INFO - Excluding off-image object: 54, order 1
2025-09-13 16:40:59,207 - jwst.assign_wcs.util - INFO - Excluding off-image object: 55, order 1
2025-09-13 16:40:59,219 - jwst.assign_wcs.util - INFO - Excluding off-image object: 56, order 1
2025-09-13 16:40:59,231 - jwst.assign_wcs.util - INFO - Excluding off-image object: 57, order 1
2025-09-13 16:40:59,243 - jwst.assign_wcs.util - INFO - Excluding off-image object: 58, order 1
2025-09-13 16:40:59,255 - jwst.assign_wcs.util - INFO - Excluding off-image object: 59, order 1
2025-09-13 16:40:59,267 - jwst.assign_wcs.util - INFO - Excluding off-image object: 60, order 1
2025-09-13 16:40:59,279 - jwst.assign_wcs.util - INFO - Excluding off-image object: 61, order 1
2025-09-13 16:40:59,291 - jwst.assign_wcs.util - INFO - Excluding off-image object: 62, order 1
2025-09-13 16:40:59,303 - jwst.assign_wcs.util - INFO - Excluding off-image object: 63, order 1
2025-09-13 16:40:59,315 - jwst.assign_wcs.util - INFO - Excluding off-image object: 64, order 1
2025-09-13 16:40:59,327 - jwst.assign_wcs.util - INFO - Excluding off-image object: 65, order 1
2025-09-13 16:40:59,340 - jwst.assign_wcs.util - INFO - Excluding off-image object: 66, order 1
2025-09-13 16:40:59,352 - jwst.assign_wcs.util - INFO - Excluding off-image object: 67, order 1
2025-09-13 16:40:59,364 - jwst.assign_wcs.util - INFO - Excluding off-image object: 68, order 1
2025-09-13 16:40:59,376 - jwst.assign_wcs.util - INFO - Excluding off-image object: 69, order 1
2025-09-13 16:40:59,388 - jwst.assign_wcs.util - INFO - Excluding off-image object: 70, order 1
2025-09-13 16:40:59,400 - jwst.assign_wcs.util - INFO - Excluding off-image object: 71, order 1
2025-09-13 16:40:59,412 - jwst.assign_wcs.util - INFO - Excluding off-image object: 72, order 1
2025-09-13 16:40:59,427 - jwst.assign_wcs.util - INFO - Excluding off-image object: 73, order 1
2025-09-13 16:40:59,438 - jwst.assign_wcs.util - INFO - Excluding off-image object: 74, order 1
2025-09-13 16:40:59,450 - jwst.assign_wcs.util - INFO - Excluding off-image object: 75, order 1
2025-09-13 16:40:59,462 - jwst.assign_wcs.util - INFO - Excluding off-image object: 76, order 1
2025-09-13 16:40:59,474 - jwst.assign_wcs.util - INFO - Excluding off-image object: 77, order 1
2025-09-13 16:40:59,486 - jwst.assign_wcs.util - INFO - Excluding off-image object: 78, order 1
2025-09-13 16:40:59,498 - jwst.assign_wcs.util - INFO - Excluding off-image object: 79, order 1
2025-09-13 16:40:59,510 - jwst.assign_wcs.util - INFO - Excluding off-image object: 80, order 1
2025-09-13 16:40:59,522 - jwst.assign_wcs.util - INFO - Excluding off-image object: 81, order 1
2025-09-13 16:40:59,534 - jwst.assign_wcs.util - INFO - Excluding off-image object: 82, order 1
2025-09-13 16:40:59,546 - jwst.assign_wcs.util - INFO - Excluding off-image object: 83, order 1
2025-09-13 16:40:59,559 - jwst.assign_wcs.util - INFO - Excluding off-image object: 84, order 1
2025-09-13 16:40:59,571 - jwst.assign_wcs.util - INFO - Excluding off-image object: 85, order 1
2025-09-13 16:40:59,583 - jwst.assign_wcs.util - INFO - Excluding off-image object: 86, order 1
2025-09-13 16:40:59,595 - jwst.assign_wcs.util - INFO - Excluding off-image object: 87, order 1
2025-09-13 16:40:59,607 - jwst.assign_wcs.util - INFO - Excluding off-image object: 88, order 1
2025-09-13 16:40:59,618 - jwst.assign_wcs.util - INFO - Excluding off-image object: 89, order 1
2025-09-13 16:40:59,630 - jwst.assign_wcs.util - INFO - Excluding off-image object: 90, order 1
2025-09-13 16:40:59,642 - jwst.assign_wcs.util - INFO - Excluding off-image object: 91, order 1
2025-09-13 16:40:59,654 - jwst.assign_wcs.util - INFO - Excluding off-image object: 92, order 1
2025-09-13 16:40:59,666 - jwst.assign_wcs.util - INFO - Excluding off-image object: 93, order 1
2025-09-13 16:40:59,679 - jwst.assign_wcs.util - INFO - Excluding off-image object: 94, order 1
2025-09-13 16:40:59,690 - jwst.assign_wcs.util - INFO - Excluding off-image object: 95, order 1
2025-09-13 16:40:59,702 - jwst.assign_wcs.util - INFO - Excluding off-image object: 96, order 1
2025-09-13 16:40:59,714 - jwst.assign_wcs.util - INFO - Excluding off-image object: 97, order 1
2025-09-13 16:40:59,726 - jwst.assign_wcs.util - INFO - Excluding off-image object: 98, order 1
2025-09-13 16:40:59,738 - jwst.assign_wcs.util - INFO - Excluding off-image object: 99, order 1
2025-09-13 16:40:59,751 - jwst.assign_wcs.util - INFO - Excluding off-image object: 100, order 1
2025-09-13 16:40:59,763 - jwst.assign_wcs.util - INFO - Excluding off-image object: 101, order 1
2025-09-13 16:40:59,775 - jwst.assign_wcs.util - INFO - Excluding off-image object: 102, order 1
2025-09-13 16:40:59,787 - jwst.assign_wcs.util - INFO - Excluding off-image object: 103, order 1
2025-09-13 16:40:59,799 - jwst.assign_wcs.util - INFO - Excluding off-image object: 104, order 1
2025-09-13 16:40:59,811 - jwst.assign_wcs.util - INFO - Excluding off-image object: 105, order 1
2025-09-13 16:40:59,823 - jwst.assign_wcs.util - INFO - Excluding off-image object: 106, order 1
2025-09-13 16:40:59,835 - jwst.assign_wcs.util - INFO - Excluding off-image object: 107, order 1
2025-09-13 16:40:59,847 - jwst.assign_wcs.util - INFO - Excluding off-image object: 108, order 1
2025-09-13 16:40:59,859 - jwst.assign_wcs.util - INFO - Excluding off-image object: 109, order 1
2025-09-13 16:40:59,871 - jwst.assign_wcs.util - INFO - Excluding off-image object: 110, order 1
2025-09-13 16:40:59,882 - jwst.assign_wcs.util - INFO - Excluding off-image object: 111, order 1
2025-09-13 16:40:59,894 - jwst.assign_wcs.util - INFO - Excluding off-image object: 112, order 1
2025-09-13 16:40:59,906 - jwst.assign_wcs.util - INFO - Excluding off-image object: 113, order 1
2025-09-13 16:40:59,918 - jwst.assign_wcs.util - INFO - Excluding off-image object: 114, order 1
2025-09-13 16:40:59,930 - jwst.assign_wcs.util - INFO - Excluding off-image object: 115, order 1
2025-09-13 16:40:59,942 - jwst.assign_wcs.util - INFO - Excluding off-image object: 116, order 1
2025-09-13 16:40:59,954 - jwst.assign_wcs.util - INFO - Excluding off-image object: 117, order 1
2025-09-13 16:40:59,973 - jwst.assign_wcs.util - INFO - Excluding off-image object: 118, order 1
2025-09-13 16:40:59,985 - jwst.assign_wcs.util - INFO - Excluding off-image object: 119, order 1
2025-09-13 16:40:59,997 - jwst.assign_wcs.util - INFO - Excluding off-image object: 120, order 1
2025-09-13 16:41:00,009 - jwst.assign_wcs.util - INFO - Excluding off-image object: 121, order 1
2025-09-13 16:41:00,022 - jwst.assign_wcs.util - INFO - Excluding off-image object: 122, order 1
2025-09-13 16:41:00,034 - jwst.assign_wcs.util - INFO - Excluding off-image object: 123, order 1
2025-09-13 16:41:00,047 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 124 order: 1
2025-09-13 16:41:00,059 - jwst.assign_wcs.util - INFO - Excluding off-image object: 125, order 1
2025-09-13 16:41:00,071 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 126 order: 1
2025-09-13 16:41:00,083 - jwst.assign_wcs.util - INFO - Excluding off-image object: 127, order 1
2025-09-13 16:41:00,095 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 128 order: 1
2025-09-13 16:41:00,107 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 129 order: 1
2025-09-13 16:41:00,119 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 130 order: 1
2025-09-13 16:41:00,131 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 131 order: 1
2025-09-13 16:41:00,155 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 133 order: 1
2025-09-13 16:41:00,363 - jwst.assign_wcs.util - INFO - Excluding off-image object: 151, order 1
2025-09-13 16:41:00,376 - jwst.assign_wcs.util - INFO - Excluding off-image object: 152, order 1
2025-09-13 16:41:00,388 - jwst.assign_wcs.util - INFO - Excluding off-image object: 153, order 1
2025-09-13 16:41:00,412 - jwst.assign_wcs.util - INFO - Excluding off-image object: 155, order 1
2025-09-13 16:41:00,668 - jwst.assign_wcs.util - INFO - Excluding off-image object: 177, order 1
2025-09-13 16:41:00,692 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 179 order: 1
2025-09-13 16:41:00,716 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 181 order: 1
2025-09-13 16:41:00,914 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 198 order: 1
2025-09-13 16:41:00,939 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 200 order: 1
2025-09-13 16:41:00,974 - jwst.assign_wcs.util - INFO - Excluding off-image object: 203, order 1
2025-09-13 16:41:01,021 - jwst.assign_wcs.util - INFO - Excluding off-image object: 207, order 1
2025-09-13 16:41:01,164 - jwst.assign_wcs.util - INFO - Excluding off-image object: 219, order 1
2025-09-13 16:41:01,223 - jwst.assign_wcs.util - INFO - Excluding off-image object: 224, order 1
2025-09-13 16:41:01,247 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 226 order: 1
2025-09-13 16:41:01,283 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 229 order: 1
2025-09-13 16:41:01,307 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 231 order: 1
2025-09-13 16:41:01,493 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 247 order: 1
2025-09-13 16:41:01,506 - jwst.assign_wcs.util - INFO - Excluding off-image object: 248, order 1
2025-09-13 16:41:01,518 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 249 order: 1
2025-09-13 16:41:01,854 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 278 order: 1
2025-09-13 16:41:02,066 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 296 order: 1
2025-09-13 16:41:02,158 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 304 order: 1
2025-09-13 16:41:02,171 - jwst.assign_wcs.util - INFO - Excluding off-image object: 305, order 1
2025-09-13 16:41:02,183 - jwst.assign_wcs.util - INFO - Excluding off-image object: 306, order 1
2025-09-13 16:41:02,391 - jwst.assign_wcs.util - INFO - Excluding off-image object: 324, order 1
2025-09-13 16:41:02,451 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 329 order: 1
2025-09-13 16:41:02,463 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 330 order: 1
2025-09-13 16:41:02,783 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 357 order: 1
2025-09-13 16:41:02,795 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 358 order: 1
2025-09-13 16:41:02,831 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 361 order: 1
2025-09-13 16:41:02,880 - jwst.assign_wcs.util - INFO - Excluding off-image object: 365, order 1
2025-09-13 16:41:02,939 - jwst.assign_wcs.util - INFO - Excluding off-image object: 370, order 1
2025-09-13 16:41:02,952 - jwst.assign_wcs.util - INFO - Excluding off-image object: 371, order 1
2025-09-13 16:41:03,012 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 376 order: 1
2025-09-13 16:41:03,154 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 388 order: 1
2025-09-13 16:41:03,559 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 423 order: 1
2025-09-13 16:41:03,816 - jwst.assign_wcs.util - INFO - Excluding off-image object: 445, order 1
2025-09-13 16:41:03,865 - jwst.assign_wcs.util - INFO - Excluding off-image object: 449, order 1
2025-09-13 16:41:04,104 - jwst.assign_wcs.util - INFO - Excluding off-image object: 469, order 1
2025-09-13 16:41:04,293 - jwst.assign_wcs.util - INFO - Excluding off-image object: 485, order 1
2025-09-13 16:41:04,456 - jwst.assign_wcs.util - INFO - Excluding off-image object: 499, order 1
2025-09-13 16:41:04,468 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 500 order: 1
2025-09-13 16:41:05,372 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 578 order: 1
2025-09-13 16:41:05,419 - jwst.assign_wcs.util - INFO - Excluding off-image object: 582, order 1
2025-09-13 16:41:05,643 - jwst.assign_wcs.util - INFO - Excluding off-image object: 601, order 1
2025-09-13 16:41:05,736 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 609 order: 1
2025-09-13 16:41:05,749 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 610 order: 1
2025-09-13 16:41:05,969 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 629 order: 1
2025-09-13 16:41:06,179 - jwst.assign_wcs.util - INFO - Excluding off-image object: 647, order 1
2025-09-13 16:41:06,329 - jwst.assign_wcs.util - INFO - Excluding off-image object: 660, order 1
2025-09-13 16:41:06,376 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 664 order: 1
2025-09-13 16:41:06,388 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 665 order: 1
2025-09-13 16:41:06,446 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 670 order: 1
2025-09-13 16:41:06,481 - jwst.assign_wcs.util - INFO - Excluding off-image object: 673, order 1
2025-09-13 16:41:06,654 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 688 order: 1
2025-09-13 16:41:06,712 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 693 order: 1
2025-09-13 16:41:06,748 - jwst.assign_wcs.util - INFO - Excluding off-image object: 696, order 1
2025-09-13 16:41:06,783 - jwst.assign_wcs.util - INFO - Excluding off-image object: 699, order 1
2025-09-13 16:41:06,980 - jwst.assign_wcs.util - INFO - Excluding off-image object: 716, order 1
2025-09-13 16:41:07,073 - jwst.assign_wcs.util - INFO - Excluding off-image object: 724, order 1
2025-09-13 16:41:07,206 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 736 order: 1
2025-09-13 16:41:07,230 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 738 order: 1
2025-09-13 16:41:07,276 - jwst.assign_wcs.util - INFO - Excluding off-image object: 742, order 1
2025-09-13 16:41:07,288 - jwst.assign_wcs.util - INFO - Excluding off-image object: 743, order 1
2025-09-13 16:41:07,369 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 750 order: 1
2025-09-13 16:41:07,452 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 757 order: 1
2025-09-13 16:41:07,488 - jwst.assign_wcs.util - INFO - Excluding off-image object: 760, order 1
2025-09-13 16:41:07,615 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 771 order: 1
2025-09-13 16:41:07,720 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 780 order: 1
2025-09-13 16:41:07,985 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 803 order: 1
2025-09-13 16:41:08,066 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 810 order: 1
2025-09-13 16:41:08,148 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 817 order: 1
2025-09-13 16:41:08,195 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 821 order: 1
2025-09-13 16:41:08,300 - jwst.assign_wcs.util - INFO - Excluding off-image object: 830, order 1
2025-09-13 16:41:08,336 - jwst.assign_wcs.util - INFO - Excluding off-image object: 833, order 1
2025-09-13 16:41:08,468 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 844 order: 1
2025-09-13 16:41:08,574 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 853 order: 1
2025-09-13 16:41:08,587 - jwst.assign_wcs.util - INFO - Excluding off-image object: 854, order 1
2025-09-13 16:41:08,866 - jwst.assign_wcs.util - INFO - Excluding off-image object: 878, order 1
2025-09-13 16:41:09,053 - jwst.assign_wcs.util - INFO - Excluding off-image object: 894, order 1
2025-09-13 16:41:09,150 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 902 order: 1
2025-09-13 16:41:09,247 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 910 order: 1
2025-09-13 16:41:09,331 - jwst.assign_wcs.util - INFO - Excluding off-image object: 917, order 1
2025-09-13 16:41:09,367 - jwst.assign_wcs.util - INFO - Excluding off-image object: 920, order 1
2025-09-13 16:41:09,709 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 949 order: 1
2025-09-13 16:41:09,768 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 954 order: 1
2025-09-13 16:41:09,828 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 959 order: 1
2025-09-13 16:41:09,841 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 960 order: 1
2025-09-13 16:41:10,067 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 979 order: 1
2025-09-13 16:41:10,150 - jwst.assign_wcs.util - INFO - Excluding off-image object: 986, order 1
2025-09-13 16:41:10,245 - jwst.assign_wcs.util - INFO - Excluding off-image object: 994, order 1
2025-09-13 16:41:10,329 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1001 order: 1
2025-09-13 16:41:10,341 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1002 order: 1
2025-09-13 16:41:10,435 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1010 order: 1
2025-09-13 16:41:10,447 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1011 order: 1
2025-09-13 16:41:10,495 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1015, order 1
2025-09-13 16:41:10,531 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1018, order 1
2025-09-13 16:41:10,555 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1020 order: 1
2025-09-13 16:41:10,720 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1034, order 1
2025-09-13 16:41:10,898 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1049 order: 1
2025-09-13 16:41:10,922 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1051 order: 1
2025-09-13 16:41:10,946 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1053 order: 1
2025-09-13 16:41:11,372 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1089 order: 1
2025-09-13 16:41:11,419 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1093, order 1
2025-09-13 16:41:11,467 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1097, order 1
2025-09-13 16:41:11,537 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1103, order 1
2025-09-13 16:41:11,618 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1110, order 1
2025-09-13 16:41:11,989 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1142 order: 1
2025-09-13 16:41:12,048 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1147 order: 1
2025-09-13 16:41:12,129 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1154, order 1
2025-09-13 16:41:12,165 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1157, order 1
2025-09-13 16:41:12,200 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1160 order: 1
2025-09-13 16:41:12,304 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1169, order 1
2025-09-13 16:41:12,352 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1173, order 1
2025-09-13 16:41:12,422 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1179, order 1
2025-09-13 16:41:12,434 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1180 order: 1
2025-09-13 16:41:12,688 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1202, order 1
2025-09-13 16:41:12,700 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1203 order: 1
2025-09-13 16:41:12,724 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1205, order 1
2025-09-13 16:41:12,794 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1211, order 1
2025-09-13 16:41:12,933 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1223, order 1
2025-09-13 16:41:12,991 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1228, order 1
2025-09-13 16:41:13,038 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1232 order: 1
2025-09-13 16:41:13,050 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1233, order 1
2025-09-13 16:41:13,156 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1242 order: 1
2025-09-13 16:41:13,421 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1265 order: 1
2025-09-13 16:41:13,659 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1286, order 1
2025-09-13 16:41:13,717 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1291 order: 1
2025-09-13 16:41:13,753 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1294 order: 1
2025-09-13 16:41:13,895 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1306 order: 1
2025-09-13 16:41:14,060 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1320, order 1
2025-09-13 16:41:14,095 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1323, order 1
2025-09-13 16:41:14,686 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1374 order: 1
2025-09-13 16:41:14,745 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1379, order 1
2025-09-13 16:41:14,814 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1385 order: 1
2025-09-13 16:41:14,896 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1392 order: 1
2025-09-13 16:41:15,012 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1402 order: 1
2025-09-13 16:41:15,267 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1424 order: 1
2025-09-13 16:41:15,279 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1425, order 1
2025-09-13 16:41:15,465 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1441, order 1
2025-09-13 16:41:15,512 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1445 order: 1
2025-09-13 16:41:15,559 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1449 order: 1
2025-09-13 16:41:15,686 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1460 order: 1
2025-09-13 16:41:15,870 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1476 order: 1
2025-09-13 16:41:15,906 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1479 order: 1
2025-09-13 16:41:15,918 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1480 order: 1
2025-09-13 16:41:15,953 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1483 order: 1
2025-09-13 16:41:15,965 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1484 order: 1
2025-09-13 16:41:15,988 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1486 order: 1
2025-09-13 16:41:16,000 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1487, order 1
2025-09-13 16:41:16,012 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1488 order: 1
2025-09-13 16:41:16,025 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1489 order: 1
2025-09-13 16:41:16,037 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1490, order 1
2025-09-13 16:41:16,049 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1491, order 1
2025-09-13 16:41:16,061 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1492, order 1
2025-09-13 16:41:16,073 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1493, order 1
2025-09-13 16:41:16,085 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1494, order 1
2025-09-13 16:41:16,097 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1495, order 1
2025-09-13 16:41:16,109 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1496, order 1
2025-09-13 16:41:16,121 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1497, order 1
2025-09-13 16:41:16,134 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1498, order 1
2025-09-13 16:41:16,146 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1499, order 1
2025-09-13 16:41:16,159 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1500, order 1
2025-09-13 16:41:16,171 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1501, order 1
2025-09-13 16:41:16,183 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1502, order 1
2025-09-13 16:41:16,184 - jwst.assign_wcs.util - INFO - Total of 1298 grism objects defined
2025-09-13 16:41:16,224 - jwst.background.background_sub_wfss - INFO - Starting iterative outlier rejection for background subtraction.
2025-09-13 16:41:16,752 - jwst.background.background_sub_wfss - INFO - Stopped at maxiter (5).
2025-09-13 16:41:16,925 - jwst.background.background_sub_wfss - INFO - Average of scaled background image = 4.442e-01
2025-09-13 16:41:16,925 - jwst.background.background_sub_wfss - INFO - Scaling factor = 4.58716e-01
2025-09-13 16:41:16,932 - stpipe.Spec2Pipeline.bkg_subtract - INFO - Step bkg_subtract done
2025-09-13 16:41:17,340 - stpipe.Spec2Pipeline.flat_field - INFO - Step flat_field running with args (<ImageModel(2048, 2048) from jw02079004003_05101_00002_nis_rate.fits>,).
2025-09-13 16:41:17,413 - stpipe.Spec2Pipeline.flat_field - INFO - Using FLAT reference file: /home/runner/crds/references/jwst/niriss/jwst_niriss_flat_0265.fits
2025-09-13 16:41:17,414 - stpipe.Spec2Pipeline.flat_field - INFO - No reference found for type FFLAT
2025-09-13 16:41:17,414 - stpipe.Spec2Pipeline.flat_field - INFO - No reference found for type SFLAT
2025-09-13 16:41:17,415 - stpipe.Spec2Pipeline.flat_field - INFO - No reference found for type DFLAT
2025-09-13 16:41:17,632 - stpipe.Spec2Pipeline.flat_field - INFO - Step flat_field done
2025-09-13 16:41:18,036 - stpipe.Spec2Pipeline.extract_2d - INFO - Step extract_2d running with args (<ImageModel(2048, 2048) from jw02079004003_05101_00002_nis_rate.fits>,).
2025-09-13 16:41:18,048 - jwst.extract_2d.extract_2d - INFO - EXP_TYPE is NIS_WFSS
2025-09-13 16:41:18,059 - jwst.assign_wcs.util - INFO - Getting objects from jw02079-o004_niriss_clear-f200w_cat.ecsv
2025-09-13 16:41:18,356 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1, order 1
2025-09-13 16:41:18,368 - jwst.assign_wcs.util - INFO - Excluding off-image object: 2, order 1
2025-09-13 16:41:18,377 - jwst.assign_wcs.util - INFO - Excluding off-image object: 3, order 1
2025-09-13 16:41:18,389 - jwst.assign_wcs.util - INFO - Excluding off-image object: 4, order 1
2025-09-13 16:41:18,400 - jwst.assign_wcs.util - INFO - Excluding off-image object: 5, order 1
2025-09-13 16:41:18,412 - jwst.assign_wcs.util - INFO - Excluding off-image object: 6, order 1
2025-09-13 16:41:18,424 - jwst.assign_wcs.util - INFO - Excluding off-image object: 7, order 1
2025-09-13 16:41:18,436 - jwst.assign_wcs.util - INFO - Excluding off-image object: 8, order 1
2025-09-13 16:41:18,448 - jwst.assign_wcs.util - INFO - Excluding off-image object: 9, order 1
2025-09-13 16:41:18,459 - jwst.assign_wcs.util - INFO - Excluding off-image object: 10, order 1
2025-09-13 16:41:18,471 - jwst.assign_wcs.util - INFO - Excluding off-image object: 11, order 1
2025-09-13 16:41:18,484 - jwst.assign_wcs.util - INFO - Excluding off-image object: 12, order 1
2025-09-13 16:41:18,495 - jwst.assign_wcs.util - INFO - Excluding off-image object: 13, order 1
2025-09-13 16:41:18,507 - jwst.assign_wcs.util - INFO - Excluding off-image object: 14, order 1
2025-09-13 16:41:18,518 - jwst.assign_wcs.util - INFO - Excluding off-image object: 15, order 1
2025-09-13 16:41:18,530 - jwst.assign_wcs.util - INFO - Excluding off-image object: 16, order 1
2025-09-13 16:41:18,541 - jwst.assign_wcs.util - INFO - Excluding off-image object: 17, order 1
2025-09-13 16:41:18,553 - jwst.assign_wcs.util - INFO - Excluding off-image object: 18, order 1
2025-09-13 16:41:18,564 - jwst.assign_wcs.util - INFO - Excluding off-image object: 19, order 1
2025-09-13 16:41:18,576 - jwst.assign_wcs.util - INFO - Excluding off-image object: 20, order 1
2025-09-13 16:41:18,587 - jwst.assign_wcs.util - INFO - Excluding off-image object: 21, order 1
2025-09-13 16:41:18,599 - jwst.assign_wcs.util - INFO - Excluding off-image object: 22, order 1
2025-09-13 16:41:18,611 - jwst.assign_wcs.util - INFO - Excluding off-image object: 23, order 1
2025-09-13 16:41:18,622 - jwst.assign_wcs.util - INFO - Excluding off-image object: 24, order 1
2025-09-13 16:41:18,634 - jwst.assign_wcs.util - INFO - Excluding off-image object: 25, order 1
2025-09-13 16:41:18,643 - jwst.assign_wcs.util - INFO - Excluding off-image object: 26, order 1
2025-09-13 16:41:18,654 - jwst.assign_wcs.util - INFO - Excluding off-image object: 27, order 1
2025-09-13 16:41:18,666 - jwst.assign_wcs.util - INFO - Excluding off-image object: 28, order 1
2025-09-13 16:41:18,677 - jwst.assign_wcs.util - INFO - Excluding off-image object: 29, order 1
2025-09-13 16:41:18,689 - jwst.assign_wcs.util - INFO - Excluding off-image object: 30, order 1
2025-09-13 16:41:18,698 - jwst.assign_wcs.util - INFO - Excluding off-image object: 31, order 1
2025-09-13 16:41:18,709 - jwst.assign_wcs.util - INFO - Excluding off-image object: 32, order 1
2025-09-13 16:41:18,718 - jwst.assign_wcs.util - INFO - Excluding off-image object: 33, order 1
2025-09-13 16:41:18,729 - jwst.assign_wcs.util - INFO - Excluding off-image object: 34, order 1
2025-09-13 16:41:18,741 - jwst.assign_wcs.util - INFO - Excluding off-image object: 35, order 1
2025-09-13 16:41:18,750 - jwst.assign_wcs.util - INFO - Excluding off-image object: 36, order 1
2025-09-13 16:41:18,761 - jwst.assign_wcs.util - INFO - Excluding off-image object: 37, order 1
2025-09-13 16:41:18,770 - jwst.assign_wcs.util - INFO - Excluding off-image object: 38, order 1
2025-09-13 16:41:18,782 - jwst.assign_wcs.util - INFO - Excluding off-image object: 39, order 1
2025-09-13 16:41:18,793 - jwst.assign_wcs.util - INFO - Excluding off-image object: 40, order 1
2025-09-13 16:41:18,805 - jwst.assign_wcs.util - INFO - Excluding off-image object: 41, order 1
2025-09-13 16:41:18,813 - jwst.assign_wcs.util - INFO - Excluding off-image object: 42, order 1
2025-09-13 16:41:18,822 - jwst.assign_wcs.util - INFO - Excluding off-image object: 43, order 1
2025-09-13 16:41:18,834 - jwst.assign_wcs.util - INFO - Excluding off-image object: 44, order 1
2025-09-13 16:41:18,845 - jwst.assign_wcs.util - INFO - Excluding off-image object: 45, order 1
2025-09-13 16:41:18,854 - jwst.assign_wcs.util - INFO - Excluding off-image object: 46, order 1
2025-09-13 16:41:18,865 - jwst.assign_wcs.util - INFO - Excluding off-image object: 47, order 1
2025-09-13 16:41:18,874 - jwst.assign_wcs.util - INFO - Excluding off-image object: 48, order 1
2025-09-13 16:41:18,886 - jwst.assign_wcs.util - INFO - Excluding off-image object: 49, order 1
2025-09-13 16:41:18,894 - jwst.assign_wcs.util - INFO - Excluding off-image object: 50, order 1
2025-09-13 16:41:18,905 - jwst.assign_wcs.util - INFO - Excluding off-image object: 51, order 1
2025-09-13 16:41:18,914 - jwst.assign_wcs.util - INFO - Excluding off-image object: 52, order 1
2025-09-13 16:41:18,923 - jwst.assign_wcs.util - INFO - Excluding off-image object: 53, order 1
2025-09-13 16:41:18,934 - jwst.assign_wcs.util - INFO - Excluding off-image object: 54, order 1
2025-09-13 16:41:18,943 - jwst.assign_wcs.util - INFO - Excluding off-image object: 55, order 1
2025-09-13 16:41:18,952 - jwst.assign_wcs.util - INFO - Excluding off-image object: 56, order 1
2025-09-13 16:41:18,964 - jwst.assign_wcs.util - INFO - Excluding off-image object: 57, order 1
2025-09-13 16:41:18,975 - jwst.assign_wcs.util - INFO - Excluding off-image object: 58, order 1
2025-09-13 16:41:18,984 - jwst.assign_wcs.util - INFO - Excluding off-image object: 59, order 1
2025-09-13 16:41:18,993 - jwst.assign_wcs.util - INFO - Excluding off-image object: 60, order 1
2025-09-13 16:41:19,001 - jwst.assign_wcs.util - INFO - Excluding off-image object: 61, order 1
2025-09-13 16:41:19,010 - jwst.assign_wcs.util - INFO - Excluding off-image object: 62, order 1
2025-09-13 16:41:19,022 - jwst.assign_wcs.util - INFO - Excluding off-image object: 63, order 1
2025-09-13 16:41:19,033 - jwst.assign_wcs.util - INFO - Excluding off-image object: 64, order 1
2025-09-13 16:41:19,042 - jwst.assign_wcs.util - INFO - Excluding off-image object: 65, order 1
2025-09-13 16:41:19,054 - jwst.assign_wcs.util - INFO - Excluding off-image object: 66, order 1
2025-09-13 16:41:19,062 - jwst.assign_wcs.util - INFO - Excluding off-image object: 67, order 1
2025-09-13 16:41:19,071 - jwst.assign_wcs.util - INFO - Excluding off-image object: 68, order 1
2025-09-13 16:41:19,083 - jwst.assign_wcs.util - INFO - Excluding off-image object: 69, order 1
2025-09-13 16:41:19,094 - jwst.assign_wcs.util - INFO - Excluding off-image object: 70, order 1
2025-09-13 16:41:19,106 - jwst.assign_wcs.util - INFO - Excluding off-image object: 71, order 1
2025-09-13 16:41:19,115 - jwst.assign_wcs.util - INFO - Excluding off-image object: 72, order 1
2025-09-13 16:41:19,124 - jwst.assign_wcs.util - INFO - Excluding off-image object: 73, order 1
2025-09-13 16:41:19,132 - jwst.assign_wcs.util - INFO - Excluding off-image object: 74, order 1
2025-09-13 16:41:19,141 - jwst.assign_wcs.util - INFO - Excluding off-image object: 75, order 1
2025-09-13 16:41:19,150 - jwst.assign_wcs.util - INFO - Excluding off-image object: 76, order 1
2025-09-13 16:41:19,161 - jwst.assign_wcs.util - INFO - Excluding off-image object: 77, order 1
2025-09-13 16:41:19,172 - jwst.assign_wcs.util - INFO - Excluding off-image object: 78, order 1
2025-09-13 16:41:19,181 - jwst.assign_wcs.util - INFO - Excluding off-image object: 79, order 1
2025-09-13 16:41:19,193 - jwst.assign_wcs.util - INFO - Excluding off-image object: 80, order 1
2025-09-13 16:41:19,201 - jwst.assign_wcs.util - INFO - Excluding off-image object: 81, order 1
2025-09-13 16:41:19,210 - jwst.assign_wcs.util - INFO - Excluding off-image object: 82, order 1
2025-09-13 16:41:19,222 - jwst.assign_wcs.util - INFO - Excluding off-image object: 83, order 1
2025-09-13 16:41:19,231 - jwst.assign_wcs.util - INFO - Excluding off-image object: 84, order 1
2025-09-13 16:41:19,239 - jwst.assign_wcs.util - INFO - Excluding off-image object: 85, order 1
2025-09-13 16:41:19,248 - jwst.assign_wcs.util - INFO - Excluding off-image object: 86, order 1
2025-09-13 16:41:19,260 - jwst.assign_wcs.util - INFO - Excluding off-image object: 87, order 1
2025-09-13 16:41:19,269 - jwst.assign_wcs.util - INFO - Excluding off-image object: 88, order 1
2025-09-13 16:41:19,277 - jwst.assign_wcs.util - INFO - Excluding off-image object: 89, order 1
2025-09-13 16:41:19,289 - jwst.assign_wcs.util - INFO - Excluding off-image object: 90, order 1
2025-09-13 16:41:19,298 - jwst.assign_wcs.util - INFO - Excluding off-image object: 91, order 1
2025-09-13 16:41:19,309 - jwst.assign_wcs.util - INFO - Excluding off-image object: 92, order 1
2025-09-13 16:41:19,318 - jwst.assign_wcs.util - INFO - Excluding off-image object: 93, order 1
2025-09-13 16:41:19,327 - jwst.assign_wcs.util - INFO - Excluding off-image object: 94, order 1
2025-09-13 16:41:19,336 - jwst.assign_wcs.util - INFO - Excluding off-image object: 95, order 1
2025-09-13 16:41:19,347 - jwst.assign_wcs.util - INFO - Excluding off-image object: 96, order 1
2025-09-13 16:41:19,359 - jwst.assign_wcs.util - INFO - Excluding off-image object: 97, order 1
2025-09-13 16:41:19,367 - jwst.assign_wcs.util - INFO - Excluding off-image object: 98, order 1
2025-09-13 16:41:19,379 - jwst.assign_wcs.util - INFO - Excluding off-image object: 99, order 1
2025-09-13 16:41:19,388 - jwst.assign_wcs.util - INFO - Excluding off-image object: 100, order 1
2025-09-13 16:41:19,397 - jwst.assign_wcs.util - INFO - Excluding off-image object: 101, order 1
2025-09-13 16:41:19,406 - jwst.assign_wcs.util - INFO - Excluding off-image object: 102, order 1
2025-09-13 16:41:19,414 - jwst.assign_wcs.util - INFO - Excluding off-image object: 103, order 1
2025-09-13 16:41:19,423 - jwst.assign_wcs.util - INFO - Excluding off-image object: 104, order 1
2025-09-13 16:41:19,435 - jwst.assign_wcs.util - INFO - Excluding off-image object: 105, order 1
2025-09-13 16:41:19,444 - jwst.assign_wcs.util - INFO - Excluding off-image object: 106, order 1
2025-09-13 16:41:19,453 - jwst.assign_wcs.util - INFO - Excluding off-image object: 107, order 1
2025-09-13 16:41:19,464 - jwst.assign_wcs.util - INFO - Excluding off-image object: 108, order 1
2025-09-13 16:41:19,473 - jwst.assign_wcs.util - INFO - Excluding off-image object: 109, order 1
2025-09-13 16:41:19,485 - jwst.assign_wcs.util - INFO - Excluding off-image object: 110, order 1
2025-09-13 16:41:19,493 - jwst.assign_wcs.util - INFO - Excluding off-image object: 111, order 1
2025-09-13 16:41:19,502 - jwst.assign_wcs.util - INFO - Excluding off-image object: 112, order 1
2025-09-13 16:41:19,511 - jwst.assign_wcs.util - INFO - Excluding off-image object: 113, order 1
2025-09-13 16:41:19,520 - jwst.assign_wcs.util - INFO - Excluding off-image object: 114, order 1
2025-09-13 16:41:19,528 - jwst.assign_wcs.util - INFO - Excluding off-image object: 115, order 1
2025-09-13 16:41:19,537 - jwst.assign_wcs.util - INFO - Excluding off-image object: 116, order 1
2025-09-13 16:41:19,546 - jwst.assign_wcs.util - INFO - Excluding off-image object: 117, order 1
2025-09-13 16:41:19,555 - jwst.assign_wcs.util - INFO - Excluding off-image object: 118, order 1
2025-09-13 16:41:19,564 - jwst.assign_wcs.util - INFO - Excluding off-image object: 119, order 1
2025-09-13 16:41:19,575 - jwst.assign_wcs.util - INFO - Excluding off-image object: 120, order 1
2025-09-13 16:41:19,584 - jwst.assign_wcs.util - INFO - Excluding off-image object: 121, order 1
2025-09-13 16:41:19,596 - jwst.assign_wcs.util - INFO - Excluding off-image object: 122, order 1
2025-09-13 16:41:19,604 - jwst.assign_wcs.util - INFO - Excluding off-image object: 123, order 1
2025-09-13 16:41:19,613 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 124 order: 1
2025-09-13 16:41:19,622 - jwst.assign_wcs.util - INFO - Excluding off-image object: 125, order 1
2025-09-13 16:41:19,631 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 126 order: 1
2025-09-13 16:41:19,640 - jwst.assign_wcs.util - INFO - Excluding off-image object: 127, order 1
2025-09-13 16:41:19,648 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 128 order: 1
2025-09-13 16:41:19,660 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 129 order: 1
2025-09-13 16:41:19,669 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 130 order: 1
2025-09-13 16:41:19,678 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 131 order: 1
2025-09-13 16:41:19,695 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 133 order: 1
2025-09-13 16:41:19,867 - jwst.assign_wcs.util - INFO - Excluding off-image object: 151, order 1
2025-09-13 16:41:19,881 - jwst.assign_wcs.util - INFO - Excluding off-image object: 152, order 1
2025-09-13 16:41:19,892 - jwst.assign_wcs.util - INFO - Excluding off-image object: 153, order 1
2025-09-13 16:41:19,912 - jwst.assign_wcs.util - INFO - Excluding off-image object: 155, order 1
2025-09-13 16:41:20,108 - jwst.assign_wcs.util - INFO - Excluding off-image object: 177, order 1
2025-09-13 16:41:20,126 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 179 order: 1
2025-09-13 16:41:20,146 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 181 order: 1
2025-09-13 16:41:20,298 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 198 order: 1
2025-09-13 16:41:20,318 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 200 order: 1
2025-09-13 16:41:20,343 - jwst.assign_wcs.util - INFO - Excluding off-image object: 203, order 1
2025-09-13 16:41:20,377 - jwst.assign_wcs.util - INFO - Excluding off-image object: 207, order 1
2025-09-13 16:41:20,485 - jwst.assign_wcs.util - INFO - Excluding off-image object: 219, order 1
2025-09-13 16:41:20,536 - jwst.assign_wcs.util - INFO - Excluding off-image object: 224, order 1
2025-09-13 16:41:20,553 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 226 order: 1
2025-09-13 16:41:20,582 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 229 order: 1
2025-09-13 16:41:20,602 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 231 order: 1
2025-09-13 16:41:20,744 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 247 order: 1
2025-09-13 16:41:20,753 - jwst.assign_wcs.util - INFO - Excluding off-image object: 248, order 1
2025-09-13 16:41:20,762 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 249 order: 1
2025-09-13 16:41:21,026 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 278 order: 1
2025-09-13 16:41:21,190 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 296 order: 1
2025-09-13 16:41:21,263 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 304 order: 1
2025-09-13 16:41:21,276 - jwst.assign_wcs.util - INFO - Excluding off-image object: 305, order 1
2025-09-13 16:41:21,287 - jwst.assign_wcs.util - INFO - Excluding off-image object: 306, order 1
2025-09-13 16:41:21,444 - jwst.assign_wcs.util - INFO - Excluding off-image object: 324, order 1
2025-09-13 16:41:21,492 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 329 order: 1
2025-09-13 16:41:21,501 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 330 order: 1
2025-09-13 16:41:21,747 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 357 order: 1
2025-09-13 16:41:21,759 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 358 order: 1
2025-09-13 16:41:21,784 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 361 order: 1
2025-09-13 16:41:21,820 - jwst.assign_wcs.util - INFO - Excluding off-image object: 365, order 1
2025-09-13 16:41:21,870 - jwst.assign_wcs.util - INFO - Excluding off-image object: 370, order 1
2025-09-13 16:41:21,882 - jwst.assign_wcs.util - INFO - Excluding off-image object: 371, order 1
2025-09-13 16:41:21,924 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 376 order: 1
2025-09-13 16:41:22,036 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 388 order: 1
2025-09-13 16:41:22,363 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 423 order: 1
2025-09-13 16:41:22,568 - jwst.assign_wcs.util - INFO - Excluding off-image object: 445, order 1
2025-09-13 16:41:22,601 - jwst.assign_wcs.util - INFO - Excluding off-image object: 449, order 1
2025-09-13 16:41:22,790 - jwst.assign_wcs.util - INFO - Excluding off-image object: 469, order 1
2025-09-13 16:41:22,932 - jwst.assign_wcs.util - INFO - Excluding off-image object: 485, order 1
2025-09-13 16:41:23,056 - jwst.assign_wcs.util - INFO - Excluding off-image object: 499, order 1
2025-09-13 16:41:23,068 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 500 order: 1
2025-09-13 16:41:23,760 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 578 order: 1
2025-09-13 16:41:23,797 - jwst.assign_wcs.util - INFO - Excluding off-image object: 582, order 1
2025-09-13 16:41:23,973 - jwst.assign_wcs.util - INFO - Excluding off-image object: 601, order 1
2025-09-13 16:41:24,045 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 609 order: 1
2025-09-13 16:41:24,057 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 610 order: 1
2025-09-13 16:41:24,232 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 629 order: 1
2025-09-13 16:41:24,394 - jwst.assign_wcs.util - INFO - Excluding off-image object: 647, order 1
2025-09-13 16:41:24,519 - jwst.assign_wcs.util - INFO - Excluding off-image object: 660, order 1
2025-09-13 16:41:24,555 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 664 order: 1
2025-09-13 16:41:24,567 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 665 order: 1
2025-09-13 16:41:24,618 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 670 order: 1
2025-09-13 16:41:24,644 - jwst.assign_wcs.util - INFO - Excluding off-image object: 673, order 1
2025-09-13 16:41:24,777 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 688 order: 1
2025-09-13 16:41:24,819 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 693 order: 1
2025-09-13 16:41:24,845 - jwst.assign_wcs.util - INFO - Excluding off-image object: 696, order 1
2025-09-13 16:41:24,873 - jwst.assign_wcs.util - INFO - Excluding off-image object: 699, order 1
2025-09-13 16:41:25,025 - jwst.assign_wcs.util - INFO - Excluding off-image object: 716, order 1
2025-09-13 16:41:25,096 - jwst.assign_wcs.util - INFO - Excluding off-image object: 724, order 1
2025-09-13 16:41:25,199 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 736 order: 1
2025-09-13 16:41:25,220 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 738 order: 1
2025-09-13 16:41:25,253 - jwst.assign_wcs.util - INFO - Excluding off-image object: 742, order 1
2025-09-13 16:41:25,262 - jwst.assign_wcs.util - INFO - Excluding off-image object: 743, order 1
2025-09-13 16:41:25,323 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 750 order: 1
2025-09-13 16:41:25,385 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 757 order: 1
2025-09-13 16:41:25,414 - jwst.assign_wcs.util - INFO - Excluding off-image object: 760, order 1
2025-09-13 16:41:25,518 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 771 order: 1
2025-09-13 16:41:25,596 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 780 order: 1
2025-09-13 16:41:25,795 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 803 order: 1
2025-09-13 16:41:25,862 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 810 order: 1
2025-09-13 16:41:25,925 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 817 order: 1
2025-09-13 16:41:25,961 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 821 order: 1
2025-09-13 16:41:26,045 - jwst.assign_wcs.util - INFO - Excluding off-image object: 830, order 1
2025-09-13 16:41:26,073 - jwst.assign_wcs.util - INFO - Excluding off-image object: 833, order 1
2025-09-13 16:41:26,171 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 844 order: 1
2025-09-13 16:41:26,253 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 853 order: 1
2025-09-13 16:41:26,262 - jwst.assign_wcs.util - INFO - Excluding off-image object: 854, order 1
2025-09-13 16:41:26,487 - jwst.assign_wcs.util - INFO - Excluding off-image object: 878, order 1
2025-09-13 16:41:26,636 - jwst.assign_wcs.util - INFO - Excluding off-image object: 894, order 1
2025-09-13 16:41:26,708 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 902 order: 1
2025-09-13 16:41:26,778 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 910 order: 1
2025-09-13 16:41:26,840 - jwst.assign_wcs.util - INFO - Excluding off-image object: 917, order 1
2025-09-13 16:41:26,866 - jwst.assign_wcs.util - INFO - Excluding off-image object: 920, order 1
2025-09-13 16:41:27,119 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 949 order: 1
2025-09-13 16:41:27,168 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 954 order: 1
2025-09-13 16:41:27,213 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 959 order: 1
2025-09-13 16:41:27,225 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 960 order: 1
2025-09-13 16:41:27,393 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 979 order: 1
2025-09-13 16:41:27,452 - jwst.assign_wcs.util - INFO - Excluding off-image object: 986, order 1
2025-09-13 16:41:27,521 - jwst.assign_wcs.util - INFO - Excluding off-image object: 994, order 1
2025-09-13 16:41:27,583 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1001 order: 1
2025-09-13 16:41:27,592 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1002 order: 1
2025-09-13 16:41:27,662 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1010 order: 1
2025-09-13 16:41:27,674 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1011 order: 1
2025-09-13 16:41:27,710 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1015, order 1
2025-09-13 16:41:27,739 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1018, order 1
2025-09-13 16:41:27,756 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1020 order: 1
2025-09-13 16:41:27,887 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1034, order 1
2025-09-13 16:41:28,024 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1049 order: 1
2025-09-13 16:41:28,043 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1051 order: 1
2025-09-13 16:41:28,061 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1053 order: 1
2025-09-13 16:41:28,387 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1089 order: 1
2025-09-13 16:41:28,427 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1093, order 1
2025-09-13 16:41:28,466 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1097, order 1
2025-09-13 16:41:28,519 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1103, order 1
2025-09-13 16:41:28,589 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1110, order 1
2025-09-13 16:41:28,869 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1142 order: 1
2025-09-13 16:41:28,917 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1147 order: 1
2025-09-13 16:41:28,979 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1154, order 1
2025-09-13 16:41:29,010 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1157, order 1
2025-09-13 16:41:29,041 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1160 order: 1
2025-09-13 16:41:29,116 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1169, order 1
2025-09-13 16:41:29,150 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1173, order 1
2025-09-13 16:41:29,203 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1179, order 1
2025-09-13 16:41:29,215 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1180 order: 1
2025-09-13 16:41:29,407 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1202, order 1
2025-09-13 16:41:29,416 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1203 order: 1
2025-09-13 16:41:29,436 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1205, order 1
2025-09-13 16:41:29,491 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1211, order 1
2025-09-13 16:41:29,602 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1223, order 1
2025-09-13 16:41:29,647 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1228, order 1
2025-09-13 16:41:29,684 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1232 order: 1
2025-09-13 16:41:29,693 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1233, order 1
2025-09-13 16:41:29,777 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1242 order: 1
2025-09-13 16:41:29,990 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1265 order: 1
2025-09-13 16:41:30,173 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1286, order 1
2025-09-13 16:41:30,223 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1291 order: 1
2025-09-13 16:41:30,251 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1294 order: 1
2025-09-13 16:41:30,359 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1306 order: 1
2025-09-13 16:41:30,484 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1320, order 1
2025-09-13 16:41:30,516 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1323, order 1
2025-09-13 16:41:30,988 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1374 order: 1
2025-09-13 16:41:31,037 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1379, order 1
2025-09-13 16:41:31,096 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1385 order: 1
2025-09-13 16:41:31,155 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1392 order: 1
2025-09-13 16:41:31,248 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1402 order: 1
2025-09-13 16:41:31,452 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1424 order: 1
2025-09-13 16:41:31,464 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1425, order 1
2025-09-13 16:41:31,614 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1441, order 1
2025-09-13 16:41:31,651 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1445 order: 1
2025-09-13 16:41:31,686 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1449 order: 1
2025-09-13 16:41:31,784 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1460 order: 1
2025-09-13 16:41:31,942 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1476 order: 1
2025-09-13 16:41:31,972 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1479 order: 1
2025-09-13 16:41:31,981 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1480 order: 1
2025-09-13 16:41:32,007 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1483 order: 1
2025-09-13 16:41:32,016 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1484 order: 1
2025-09-13 16:41:32,036 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1486 order: 1
2025-09-13 16:41:32,045 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1487, order 1
2025-09-13 16:41:32,054 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1488 order: 1
2025-09-13 16:41:32,066 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1489 order: 1
2025-09-13 16:41:32,078 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1490 order: 1
2025-09-13 16:41:32,087 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1491, order 1
2025-09-13 16:41:32,096 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1492, order 1
2025-09-13 16:41:32,105 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1493, order 1
2025-09-13 16:41:32,114 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1494, order 1
2025-09-13 16:41:32,123 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1495, order 1
2025-09-13 16:41:32,132 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1496, order 1
2025-09-13 16:41:32,141 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1497, order 1
2025-09-13 16:41:32,150 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1498, order 1
2025-09-13 16:41:32,159 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1499, order 1
2025-09-13 16:41:32,171 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1500, order 1
2025-09-13 16:41:32,185 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1501, order 1
2025-09-13 16:41:32,197 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1502, order 1
2025-09-13 16:41:32,201 - jwst.assign_wcs.util - INFO - Total of 100 grism objects defined
2025-09-13 16:41:32,227 - jwst.extract_2d.grisms - INFO - Grism object list created from source catalog: jw02079-o004_niriss_clear-f200w_cat.ecsv
2025-09-13 16:41:32,229 - jwst.extract_2d.grisms - INFO - Extracting 100 grism objects
2025-09-13 16:41:32,338 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 522 order: 1:
2025-09-13 16:41:32,339 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:521, xmax:791), (ymin:563, ymax:710)
2025-09-13 16:41:32,521 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 796 order: 1:
2025-09-13 16:41:32,522 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1702, xmax:1919), (ymin:989, ymax:1084)
2025-09-13 16:41:32,703 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 1479 order: 1:
2025-09-13 16:41:32,704 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:48, xmax:274), (ymin:2025, ymax:2048)
2025-09-13 16:41:32,881 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 214 order: 1:
2025-09-13 16:41:32,882 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:216, xmax:423), (ymin:134, ymax:239)
2025-09-13 16:41:33,055 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 693 order: 1:
2025-09-13 16:41:33,056 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:0, xmax:191), (ymin:818, ymax:893)
2025-09-13 16:41:33,231 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 1120 order: 1:
2025-09-13 16:41:33,232 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:415, xmax:648), (ymin:1448, ymax:1515)
2025-09-13 16:41:33,406 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 1257 order: 1:
2025-09-13 16:41:33,407 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1357, xmax:1582), (ymin:1642, ymax:1718)
2025-09-13 16:41:34,014 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 766 order: 1:
2025-09-13 16:41:34,014 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:858, xmax:1033), (ymin:946, ymax:1048)
2025-09-13 16:41:34,194 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 606 order: 1:
2025-09-13 16:41:34,195 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:316, xmax:509), (ymin:707, ymax:717)
2025-09-13 16:41:34,374 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 649 order: 1:
2025-09-13 16:41:34,374 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1444, xmax:1656), (ymin:748, ymax:842)
2025-09-13 16:41:34,555 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 982 order: 1:
2025-09-13 16:41:34,556 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:304, xmax:476), (ymin:1244, ymax:1299)
2025-09-13 16:41:34,735 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 1364 order: 1:
2025-09-13 16:41:34,736 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1267, xmax:1433), (ymin:1816, ymax:1876)
2025-09-13 16:41:34,912 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 898 order: 1:
2025-09-13 16:41:34,913 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1307, xmax:1474), (ymin:1161, ymax:1171)
2025-09-13 16:41:35,086 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 1049 order: 1:
2025-09-13 16:41:35,087 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:0, xmax:37), (ymin:1342, ymax:1417)
2025-09-13 16:41:35,258 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 732 order: 1:
2025-09-13 16:41:35,258 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:403, xmax:590), (ymin:888, ymax:932)
2025-09-13 16:41:35,435 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 189 order: 1:
2025-09-13 16:41:35,435 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1021, xmax:1191), (ymin:101, ymax:147)
2025-09-13 16:41:35,611 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 881 order: 1:
2025-09-13 16:41:35,612 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1023, xmax:1215), (ymin:1126, ymax:1136)
2025-09-13 16:41:35,785 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 966 order: 1:
2025-09-13 16:41:35,786 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1291, xmax:1468), (ymin:1236, ymax:1295)
2025-09-13 16:41:35,958 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 914 order: 1:
2025-09-13 16:41:35,959 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1671, xmax:1836), (ymin:1156, ymax:1187)
2025-09-13 16:41:36,135 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 1084 order: 1:
2025-09-13 16:41:36,136 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1696, xmax:1870), (ymin:1423, ymax:1433)
2025-09-13 16:41:36,306 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 540 order: 1:
2025-09-13 16:41:36,306 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1587, xmax:1771), (ymin:590, ymax:661)
2025-09-13 16:41:36,485 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 1476 order: 1:
2025-09-13 16:41:36,485 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:0, xmax:61), (ymin:2023, ymax:2048)
2025-09-13 16:41:36,658 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 1142 order: 1:
2025-09-13 16:41:36,658 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:0, xmax:143), (ymin:1477, ymax:1523)
2025-09-13 16:41:36,831 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 220 order: 1:
2025-09-13 16:41:36,832 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:33, xmax:203), (ymin:161, ymax:171)
2025-09-13 16:41:37,005 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 289 order: 1:
2025-09-13 16:41:37,006 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1764, xmax:1934), (ymin:247, ymax:282)
2025-09-13 16:41:37,183 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 934 order: 1:
2025-09-13 16:41:37,184 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:584, xmax:756), (ymin:1182, ymax:1228)
2025-09-13 16:41:37,355 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 1219 order: 1:
2025-09-13 16:41:37,356 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:821, xmax:989), (ymin:1593, ymax:1653)
2025-09-13 16:41:37,530 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 927 order: 1:
2025-09-13 16:41:37,531 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:682, xmax:857), (ymin:1168, ymax:1212)
2025-09-13 16:41:37,703 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 1417 order: 1:
2025-09-13 16:41:37,704 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:31, xmax:194), (ymin:1912, ymax:1949)
2025-09-13 16:41:37,874 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 567 order: 1:
2025-09-13 16:41:37,874 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1551, xmax:1718), (ymin:638, ymax:686)
2025-09-13 16:41:38,047 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 1296 order: 1:
2025-09-13 16:41:38,047 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:525, xmax:691), (ymin:1696, ymax:1739)
2025-09-13 16:41:38,224 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 1412 order: 1:
2025-09-13 16:41:38,225 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:747, xmax:909), (ymin:1907, ymax:1946)
2025-09-13 16:41:38,402 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 654 order: 1:
2025-09-13 16:41:38,403 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1657, xmax:1844), (ymin:757, ymax:816)
2025-09-13 16:41:38,579 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 1029 order: 1:
2025-09-13 16:41:38,579 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:2, xmax:199), (ymin:1308, ymax:1364)
2025-09-13 16:41:38,760 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 553 order: 1:
2025-09-13 16:41:38,760 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:323, xmax:493), (ymin:605, ymax:640)
2025-09-13 16:41:38,938 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 1387 order: 1:
2025-09-13 16:41:38,938 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1879, xmax:2040), (ymin:1862, ymax:1902)
2025-09-13 16:41:39,653 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 422 order: 1:
2025-09-13 16:41:39,653 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1434, xmax:1588), (ymin:414, ymax:442)
2025-09-13 16:41:39,832 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 821 order: 1:
2025-09-13 16:41:39,832 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:0, xmax:157), (ymin:1007, ymax:1049)
2025-09-13 16:41:40,008 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 682 order: 1:
2025-09-13 16:41:40,009 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:851, xmax:1016), (ymin:812, ymax:862)
2025-09-13 16:41:40,190 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 1140 order: 1:
2025-09-13 16:41:40,190 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1515, xmax:1685), (ymin:1484, ymax:1526)
2025-09-13 16:41:40,368 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 1388 order: 1:
2025-09-13 16:41:40,368 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1651, xmax:1824), (ymin:1863, ymax:1921)
2025-09-13 16:41:40,544 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 759 order: 1:
2025-09-13 16:41:40,545 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1048, xmax:1216), (ymin:938, ymax:978)
2025-09-13 16:41:40,721 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 1407 order: 1:
2025-09-13 16:41:40,722 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1144, xmax:1309), (ymin:1891, ymax:1926)
2025-09-13 16:41:40,898 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 1194 order: 1:
2025-09-13 16:41:40,899 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1570, xmax:1734), (ymin:1546, ymax:1575)
2025-09-13 16:41:41,072 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 712 order: 1:
2025-09-13 16:41:41,073 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1186, xmax:1349), (ymin:858, ymax:892)
2025-09-13 16:41:41,246 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 539 order: 1:
2025-09-13 16:41:41,247 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1497, xmax:1647), (ymin:590, ymax:632)
2025-09-13 16:41:41,421 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 1008 order: 1:
2025-09-13 16:41:41,422 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:908, xmax:1063), (ymin:1287, ymax:1317)
2025-09-13 16:41:41,598 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 347 order: 1:
2025-09-13 16:41:41,598 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:586, xmax:740), (ymin:321, ymax:331)
2025-09-13 16:41:41,774 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 276 order: 1:
2025-09-13 16:41:41,774 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1180, xmax:1345), (ymin:223, ymax:267)
2025-09-13 16:41:41,950 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 605 order: 1:
2025-09-13 16:41:41,951 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:216, xmax:363), (ymin:684, ymax:694)
2025-09-13 16:41:42,126 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 922 order: 1:
2025-09-13 16:41:42,127 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1598, xmax:1751), (ymin:1165, ymax:1194)
2025-09-13 16:41:42,301 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 736 order: 1:
2025-09-13 16:41:42,301 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1922, xmax:2048), (ymin:903, ymax:925)
2025-09-13 16:41:42,476 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 1423 order: 1:
2025-09-13 16:41:42,477 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:87, xmax:244), (ymin:1932, ymax:1963)
2025-09-13 16:41:42,651 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 800 order: 1:
2025-09-13 16:41:42,651 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:673, xmax:824), (ymin:988, ymax:1014)
2025-09-13 16:41:42,824 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 873 order: 1:
2025-09-13 16:41:42,825 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1888, xmax:2033), (ymin:1096, ymax:1123)
2025-09-13 16:41:42,998 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 385 order: 1:
2025-09-13 16:41:42,999 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:310, xmax:474), (ymin:355, ymax:375)
2025-09-13 16:41:43,169 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 557 order: 1:
2025-09-13 16:41:43,170 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:208, xmax:370), (ymin:618, ymax:655)
2025-09-13 16:41:43,341 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 719 order: 1:
2025-09-13 16:41:43,342 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1472, xmax:1618), (ymin:869, ymax:898)
2025-09-13 16:41:43,514 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 389 order: 1:
2025-09-13 16:41:43,515 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:366, xmax:522), (ymin:359, ymax:389)
2025-09-13 16:41:43,687 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 733 order: 1:
2025-09-13 16:41:43,688 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1740, xmax:1916), (ymin:898, ymax:941)
2025-09-13 16:41:43,864 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 1442 order: 1:
2025-09-13 16:41:43,865 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:562, xmax:729), (ymin:1967, ymax:2010)
2025-09-13 16:41:44,041 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 417 order: 1:
2025-09-13 16:41:44,042 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:820, xmax:968), (ymin:401, ymax:430)
2025-09-13 16:41:44,218 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 630 order: 1:
2025-09-13 16:41:44,218 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1787, xmax:1928), (ymin:717, ymax:727)
2025-09-13 16:41:44,394 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 925 order: 1:
2025-09-13 16:41:44,395 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:302, xmax:467), (ymin:1161, ymax:1193)
2025-09-13 16:41:44,571 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 527 order: 1:
2025-09-13 16:41:44,572 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1779, xmax:1929), (ymin:576, ymax:611)
2025-09-13 16:41:44,747 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 439 order: 1:
2025-09-13 16:41:44,748 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:683, xmax:843), (ymin:442, ymax:452)
2025-09-13 16:41:45,577 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 1253 order: 1:
2025-09-13 16:41:45,578 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:131, xmax:278), (ymin:1632, ymax:1664)
2025-09-13 16:41:45,755 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 1162 order: 1:
2025-09-13 16:41:45,756 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:813, xmax:957), (ymin:1504, ymax:1522)
2025-09-13 16:41:45,937 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 1457 order: 1:
2025-09-13 16:41:45,937 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:166, xmax:314), (ymin:1993, ymax:2017)
2025-09-13 16:41:46,115 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 694 order: 1:
2025-09-13 16:41:46,116 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:250, xmax:418), (ymin:820, ymax:842)
2025-09-13 16:41:46,294 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 1266 order: 1:
2025-09-13 16:41:46,295 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:715, xmax:875), (ymin:1655, ymax:1681)
2025-09-13 16:41:46,472 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 298 order: 1:
2025-09-13 16:41:46,473 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1049, xmax:1204), (ymin:253, ymax:275)
2025-09-13 16:41:46,654 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 516 order: 1:
2025-09-13 16:41:46,655 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:481, xmax:634), (ymin:555, ymax:588)
2025-09-13 16:41:46,835 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 973 order: 1:
2025-09-13 16:41:46,836 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:456, xmax:602), (ymin:1238, ymax:1258)
2025-09-13 16:41:47,014 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 180 order: 1:
2025-09-13 16:41:47,015 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1379, xmax:1544), (ymin:91, ymax:123)
2025-09-13 16:41:47,195 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 980 order: 1:
2025-09-13 16:41:47,196 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1364, xmax:1525), (ymin:1249, ymax:1279)
2025-09-13 16:41:47,374 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 263 order: 1:
2025-09-13 16:41:47,374 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:835, xmax:995), (ymin:195, ymax:219)
2025-09-13 16:41:47,552 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 493 order: 1:
2025-09-13 16:41:47,553 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1416, xmax:1569), (ymin:521, ymax:551)
2025-09-13 16:41:47,746 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 981 order: 1:
2025-09-13 16:41:47,746 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1734, xmax:1876), (ymin:1251, ymax:1274)
2025-09-13 16:41:47,923 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 1371 order: 1:
2025-09-13 16:41:47,924 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:630, xmax:778), (ymin:1824, ymax:1846)
2025-09-13 16:41:48,100 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 536 order: 1:
2025-09-13 16:41:48,101 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:383, xmax:529), (ymin:579, ymax:612)
2025-09-13 16:41:48,277 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 749 order: 1:
2025-09-13 16:41:48,277 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1492, xmax:1639), (ymin:925, ymax:947)
2025-09-13 16:41:48,451 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 345 order: 1:
2025-09-13 16:41:48,452 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:857, xmax:1001), (ymin:310, ymax:331)
2025-09-13 16:41:48,624 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 721 order: 1:
2025-09-13 16:41:48,625 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:126, xmax:266), (ymin:866, ymax:876)
2025-09-13 16:41:48,820 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 387 order: 1:
2025-09-13 16:41:48,821 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1392, xmax:1538), (ymin:363, ymax:382)
2025-09-13 16:41:48,999 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 505 order: 1:
2025-09-13 16:41:49,000 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1446, xmax:1591), (ymin:551, ymax:572)
2025-09-13 16:41:49,177 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 566 order: 1:
2025-09-13 16:41:49,178 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1121, xmax:1267), (ymin:636, ymax:672)
2025-09-13 16:41:49,354 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 772 order: 1:
2025-09-13 16:41:49,355 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1623, xmax:1771), (ymin:954, ymax:979)
2025-09-13 16:41:49,531 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 722 order: 1:
2025-09-13 16:41:49,532 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:397, xmax:551), (ymin:865, ymax:892)
2025-09-13 16:41:49,707 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 872 order: 1:
2025-09-13 16:41:49,708 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1428, xmax:1576), (ymin:1097, ymax:1107)
2025-09-13 16:41:49,881 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 933 order: 1:
2025-09-13 16:41:49,882 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:33, xmax:192), (ymin:1178, ymax:1202)
2025-09-13 16:41:50,054 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 1128 order: 1:
2025-09-13 16:41:50,055 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1698, xmax:1836), (ymin:1469, ymax:1479)
2025-09-13 16:41:50,231 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 1282 order: 1:
2025-09-13 16:41:50,231 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:804, xmax:962), (ymin:1685, ymax:1719)
2025-09-13 16:41:50,406 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 274 order: 1:
2025-09-13 16:41:50,407 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:397, xmax:551), (ymin:211, ymax:242)
2025-09-13 16:41:50,583 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 124 order: 1:
2025-09-13 16:41:50,584 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1075, xmax:1216), (ymin:0, ymax:6)
2025-09-13 16:41:50,756 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 641 order: 1:
2025-09-13 16:41:50,757 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1530, xmax:1682), (ymin:733, ymax:756)
2025-09-13 16:41:50,933 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 543 order: 1:
2025-09-13 16:41:50,934 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:137, xmax:291), (ymin:588, ymax:617)
2025-09-13 16:41:51,110 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 610 order: 1:
2025-09-13 16:41:51,111 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:0, xmax:23), (ymin:702, ymax:712)
2025-09-13 16:41:51,285 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 1188 order: 1:
2025-09-13 16:41:51,286 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:446, xmax:587), (ymin:1534, ymax:1572)
2025-09-13 16:41:51,462 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 533 order: 1:
2025-09-13 16:41:51,463 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1326, xmax:1473), (ymin:581, ymax:602)
2025-09-13 16:41:54,754 - jwst.extract_2d.grisms - INFO - Finished extractions
2025-09-13 16:41:54,787 - stpipe.Spec2Pipeline.extract_2d - INFO - Step extract_2d done
2025-09-13 16:41:55,367 - stpipe.Spec2Pipeline.srctype - INFO - Step srctype running with args (<MultiSlitModel from jw02079004003_05101_00002_nis_rate.fits>,).
2025-09-13 16:41:55,374 - jwst.srctype.srctype - INFO - Input EXP_TYPE is NIS_WFSS
2025-09-13 16:41:55,375 - jwst.srctype.srctype - INFO - source_id=522, type=EXTENDED
2025-09-13 16:41:55,375 - jwst.srctype.srctype - INFO - source_id=796, type=EXTENDED
2025-09-13 16:41:55,376 - jwst.srctype.srctype - INFO - source_id=1479, type=EXTENDED
2025-09-13 16:41:55,376 - jwst.srctype.srctype - INFO - source_id=214, type=EXTENDED
2025-09-13 16:41:55,377 - jwst.srctype.srctype - INFO - source_id=693, type=EXTENDED
2025-09-13 16:41:55,378 - jwst.srctype.srctype - INFO - source_id=1120, type=EXTENDED
2025-09-13 16:41:55,378 - jwst.srctype.srctype - INFO - source_id=1257, type=EXTENDED
2025-09-13 16:41:55,379 - jwst.srctype.srctype - INFO - source_id=766, type=EXTENDED
2025-09-13 16:41:55,379 - jwst.srctype.srctype - INFO - source_id=606, type=POINT
2025-09-13 16:41:55,380 - jwst.srctype.srctype - INFO - source_id=649, type=EXTENDED
2025-09-13 16:41:55,380 - jwst.srctype.srctype - INFO - source_id=982, type=EXTENDED
2025-09-13 16:41:55,381 - jwst.srctype.srctype - INFO - source_id=1364, type=EXTENDED
2025-09-13 16:41:55,381 - jwst.srctype.srctype - INFO - source_id=898, type=POINT
2025-09-13 16:41:55,382 - jwst.srctype.srctype - INFO - source_id=1049, type=EXTENDED
2025-09-13 16:41:55,382 - jwst.srctype.srctype - INFO - source_id=732, type=EXTENDED
2025-09-13 16:41:55,383 - jwst.srctype.srctype - INFO - source_id=189, type=EXTENDED
2025-09-13 16:41:55,384 - jwst.srctype.srctype - INFO - source_id=881, type=POINT
2025-09-13 16:41:55,384 - jwst.srctype.srctype - INFO - source_id=966, type=EXTENDED
2025-09-13 16:41:55,385 - jwst.srctype.srctype - INFO - source_id=914, type=EXTENDED
2025-09-13 16:41:55,385 - jwst.srctype.srctype - INFO - source_id=1084, type=POINT
2025-09-13 16:41:55,386 - jwst.srctype.srctype - INFO - source_id=540, type=EXTENDED
2025-09-13 16:41:55,386 - jwst.srctype.srctype - INFO - source_id=1476, type=EXTENDED
2025-09-13 16:41:55,387 - jwst.srctype.srctype - INFO - source_id=1142, type=EXTENDED
2025-09-13 16:41:55,387 - jwst.srctype.srctype - INFO - source_id=220, type=POINT
2025-09-13 16:41:55,388 - jwst.srctype.srctype - INFO - source_id=289, type=EXTENDED
2025-09-13 16:41:55,388 - jwst.srctype.srctype - INFO - source_id=934, type=EXTENDED
2025-09-13 16:41:55,389 - jwst.srctype.srctype - INFO - source_id=1219, type=EXTENDED
2025-09-13 16:41:55,389 - jwst.srctype.srctype - INFO - source_id=927, type=EXTENDED
2025-09-13 16:41:55,390 - jwst.srctype.srctype - INFO - source_id=1417, type=EXTENDED
2025-09-13 16:41:55,390 - jwst.srctype.srctype - INFO - source_id=567, type=EXTENDED
2025-09-13 16:41:55,391 - jwst.srctype.srctype - INFO - source_id=1296, type=EXTENDED
2025-09-13 16:41:55,392 - jwst.srctype.srctype - INFO - source_id=1412, type=EXTENDED
2025-09-13 16:41:55,392 - jwst.srctype.srctype - INFO - source_id=654, type=EXTENDED
2025-09-13 16:41:55,393 - jwst.srctype.srctype - INFO - source_id=1029, type=EXTENDED
2025-09-13 16:41:55,393 - jwst.srctype.srctype - INFO - source_id=553, type=EXTENDED
2025-09-13 16:41:55,394 - jwst.srctype.srctype - INFO - source_id=1387, type=EXTENDED
2025-09-13 16:41:55,395 - jwst.srctype.srctype - INFO - source_id=422, type=EXTENDED
2025-09-13 16:41:55,395 - jwst.srctype.srctype - INFO - source_id=821, type=EXTENDED
2025-09-13 16:41:55,396 - jwst.srctype.srctype - INFO - source_id=682, type=EXTENDED
2025-09-13 16:41:55,396 - jwst.srctype.srctype - INFO - source_id=1140, type=EXTENDED
2025-09-13 16:41:55,397 - jwst.srctype.srctype - INFO - source_id=1388, type=EXTENDED
2025-09-13 16:41:55,397 - jwst.srctype.srctype - INFO - source_id=759, type=EXTENDED
2025-09-13 16:41:55,398 - jwst.srctype.srctype - INFO - source_id=1407, type=EXTENDED
2025-09-13 16:41:55,398 - jwst.srctype.srctype - INFO - source_id=1194, type=EXTENDED
2025-09-13 16:41:55,399 - jwst.srctype.srctype - INFO - source_id=712, type=EXTENDED
2025-09-13 16:41:55,400 - jwst.srctype.srctype - INFO - source_id=539, type=EXTENDED
2025-09-13 16:41:55,400 - jwst.srctype.srctype - INFO - source_id=1008, type=EXTENDED
2025-09-13 16:41:55,401 - jwst.srctype.srctype - INFO - source_id=347, type=POINT
2025-09-13 16:41:55,401 - jwst.srctype.srctype - INFO - source_id=276, type=EXTENDED
2025-09-13 16:41:55,402 - jwst.srctype.srctype - INFO - source_id=605, type=POINT
2025-09-13 16:41:55,402 - jwst.srctype.srctype - INFO - source_id=922, type=EXTENDED
2025-09-13 16:41:55,403 - jwst.srctype.srctype - INFO - source_id=736, type=EXTENDED
2025-09-13 16:41:55,403 - jwst.srctype.srctype - INFO - source_id=1423, type=EXTENDED
2025-09-13 16:41:55,404 - jwst.srctype.srctype - INFO - source_id=800, type=EXTENDED
2025-09-13 16:41:55,405 - jwst.srctype.srctype - INFO - source_id=873, type=EXTENDED
2025-09-13 16:41:55,405 - jwst.srctype.srctype - INFO - source_id=385, type=EXTENDED
2025-09-13 16:41:55,406 - jwst.srctype.srctype - INFO - source_id=557, type=EXTENDED
2025-09-13 16:41:55,406 - jwst.srctype.srctype - INFO - source_id=719, type=EXTENDED
2025-09-13 16:41:55,407 - jwst.srctype.srctype - INFO - source_id=389, type=EXTENDED
2025-09-13 16:41:55,407 - jwst.srctype.srctype - INFO - source_id=733, type=EXTENDED
2025-09-13 16:41:55,408 - jwst.srctype.srctype - INFO - source_id=1442, type=EXTENDED
2025-09-13 16:41:55,409 - jwst.srctype.srctype - INFO - source_id=417, type=EXTENDED
2025-09-13 16:41:55,409 - jwst.srctype.srctype - INFO - source_id=630, type=POINT
2025-09-13 16:41:55,410 - jwst.srctype.srctype - INFO - source_id=925, type=EXTENDED
2025-09-13 16:41:55,410 - jwst.srctype.srctype - INFO - source_id=527, type=EXTENDED
2025-09-13 16:41:55,411 - jwst.srctype.srctype - INFO - source_id=439, type=POINT
2025-09-13 16:41:55,411 - jwst.srctype.srctype - INFO - source_id=1253, type=EXTENDED
2025-09-13 16:41:55,412 - jwst.srctype.srctype - INFO - source_id=1162, type=EXTENDED
2025-09-13 16:41:55,412 - jwst.srctype.srctype - INFO - source_id=1457, type=EXTENDED
2025-09-13 16:41:55,413 - jwst.srctype.srctype - INFO - source_id=694, type=EXTENDED
2025-09-13 16:41:55,413 - jwst.srctype.srctype - INFO - source_id=1266, type=EXTENDED
2025-09-13 16:41:55,414 - jwst.srctype.srctype - INFO - source_id=298, type=EXTENDED
2025-09-13 16:41:55,415 - jwst.srctype.srctype - INFO - source_id=516, type=EXTENDED
2025-09-13 16:41:55,415 - jwst.srctype.srctype - INFO - source_id=973, type=EXTENDED
2025-09-13 16:41:55,416 - jwst.srctype.srctype - INFO - source_id=180, type=EXTENDED
2025-09-13 16:41:55,416 - jwst.srctype.srctype - INFO - source_id=980, type=EXTENDED
2025-09-13 16:41:55,417 - jwst.srctype.srctype - INFO - source_id=263, type=EXTENDED
2025-09-13 16:41:55,417 - jwst.srctype.srctype - INFO - source_id=493, type=EXTENDED
2025-09-13 16:41:55,418 - jwst.srctype.srctype - INFO - source_id=981, type=EXTENDED
2025-09-13 16:41:55,418 - jwst.srctype.srctype - INFO - source_id=1371, type=EXTENDED
2025-09-13 16:41:55,419 - jwst.srctype.srctype - INFO - source_id=536, type=EXTENDED
2025-09-13 16:41:55,419 - jwst.srctype.srctype - INFO - source_id=749, type=EXTENDED
2025-09-13 16:41:55,420 - jwst.srctype.srctype - INFO - source_id=345, type=EXTENDED
2025-09-13 16:41:55,420 - jwst.srctype.srctype - INFO - source_id=721, type=POINT
2025-09-13 16:41:55,421 - jwst.srctype.srctype - INFO - source_id=387, type=EXTENDED
2025-09-13 16:41:55,421 - jwst.srctype.srctype - INFO - source_id=505, type=EXTENDED
2025-09-13 16:41:55,422 - jwst.srctype.srctype - INFO - source_id=566, type=EXTENDED
2025-09-13 16:41:55,422 - jwst.srctype.srctype - INFO - source_id=772, type=EXTENDED
2025-09-13 16:41:55,423 - jwst.srctype.srctype - INFO - source_id=722, type=EXTENDED
2025-09-13 16:41:55,423 - jwst.srctype.srctype - INFO - source_id=872, type=POINT
2025-09-13 16:41:55,424 - jwst.srctype.srctype - INFO - source_id=933, type=EXTENDED
2025-09-13 16:41:55,425 - jwst.srctype.srctype - INFO - source_id=1128, type=POINT
2025-09-13 16:41:55,425 - jwst.srctype.srctype - INFO - source_id=1282, type=EXTENDED
2025-09-13 16:41:55,426 - jwst.srctype.srctype - INFO - source_id=274, type=EXTENDED
2025-09-13 16:41:55,426 - jwst.srctype.srctype - INFO - source_id=124, type=EXTENDED
2025-09-13 16:41:55,427 - jwst.srctype.srctype - INFO - source_id=641, type=EXTENDED
2025-09-13 16:41:55,427 - jwst.srctype.srctype - INFO - source_id=543, type=EXTENDED
2025-09-13 16:41:55,428 - jwst.srctype.srctype - INFO - source_id=610, type=POINT
2025-09-13 16:41:55,428 - jwst.srctype.srctype - INFO - source_id=1188, type=EXTENDED
2025-09-13 16:41:55,429 - jwst.srctype.srctype - INFO - source_id=533, type=EXTENDED
2025-09-13 16:41:55,431 - stpipe.Spec2Pipeline.srctype - INFO - Step srctype done
2025-09-13 16:41:56,015 - stpipe.Spec2Pipeline.straylight - INFO - Step straylight running with args (<MultiSlitModel from jw02079004003_05101_00002_nis_rate.fits>,).
2025-09-13 16:41:56,017 - stpipe.Spec2Pipeline.straylight - INFO - Step skipped.
2025-09-13 16:41:56,554 - stpipe.Spec2Pipeline.fringe - INFO - Step fringe running with args (<MultiSlitModel from jw02079004003_05101_00002_nis_rate.fits>,).
2025-09-13 16:41:56,554 - stpipe.Spec2Pipeline.fringe - INFO - Step skipped.
2025-09-13 16:41:57,102 - stpipe.Spec2Pipeline.pathloss - INFO - Step pathloss running with args (<MultiSlitModel from jw02079004003_05101_00002_nis_rate.fits>,).
2025-09-13 16:41:57,102 - stpipe.Spec2Pipeline.pathloss - INFO - Step skipped.
2025-09-13 16:41:57,647 - stpipe.Spec2Pipeline.barshadow - INFO - Step barshadow running with args (<MultiSlitModel from jw02079004003_05101_00002_nis_rate.fits>,).
2025-09-13 16:41:57,648 - stpipe.Spec2Pipeline.barshadow - INFO - Step skipped.
2025-09-13 16:41:58,188 - stpipe.Spec2Pipeline.wfss_contam - INFO - Step wfss_contam running with args (<MultiSlitModel from jw02079004003_05101_00002_nis_rate.fits>,).
2025-09-13 16:41:58,189 - stpipe.Spec2Pipeline.wfss_contam - INFO - Step skipped.
2025-09-13 16:41:58,730 - stpipe.Spec2Pipeline.photom - INFO - Step photom running with args (<MultiSlitModel from jw02079004003_05101_00002_nis_rate.fits>,).
2025-09-13 16:41:58,775 - stpipe.Spec2Pipeline.photom - INFO - Using photom reference file: /home/runner/crds/references/jwst/niriss/jwst_niriss_photom_0041.fits
2025-09-13 16:41:58,776 - stpipe.Spec2Pipeline.photom - INFO - Using area reference file: N/A
2025-09-13 16:42:01,872 - jwst.photom.photom - INFO - Using instrument: NIRISS
2025-09-13 16:42:01,872 - jwst.photom.photom - INFO - detector: NIS
2025-09-13 16:42:01,873 - jwst.photom.photom - INFO - exp_type: NIS_WFSS
2025-09-13 16:42:01,873 - jwst.photom.photom - INFO - filter: GR150C
2025-09-13 16:42:01,874 - jwst.photom.photom - INFO - pupil: F200W
2025-09-13 16:42:01,893 - jwst.photom.photom - INFO - Attempting to obtain PIXAR_SR and PIXAR_A2 values from PHOTOM reference file.
2025-09-13 16:42:01,894 - jwst.photom.photom - INFO - Values for PIXAR_SR and PIXAR_A2 obtained from PHOTOM reference file.
2025-09-13 16:42:01,928 - jwst.photom.photom - INFO - Working on slit 522, order 1
2025-09-13 16:42:01,929 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:42:01,934 - jwst.photom.photom - INFO - Working on slit 796, order 1
2025-09-13 16:42:01,935 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:42:01,939 - jwst.photom.photom - INFO - Working on slit 1479, order 1
2025-09-13 16:42:01,940 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:42:01,943 - jwst.photom.photom - INFO - Working on slit 214, order 1
2025-09-13 16:42:01,944 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:42:01,948 - jwst.photom.photom - INFO - Working on slit 693, order 1
2025-09-13 16:42:01,949 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:42:01,953 - jwst.photom.photom - INFO - Working on slit 1120, order 1
2025-09-13 16:42:01,954 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:42:01,958 - jwst.photom.photom - INFO - Working on slit 1257, order 1
2025-09-13 16:42:01,959 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:42:01,963 - jwst.photom.photom - INFO - Working on slit 766, order 1
2025-09-13 16:42:01,963 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:42:01,968 - jwst.photom.photom - INFO - Working on slit 606, order 1
2025-09-13 16:42:01,968 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:42:01,972 - jwst.photom.photom - INFO - Working on slit 649, order 1
2025-09-13 16:42:01,972 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:42:01,977 - jwst.photom.photom - INFO - Working on slit 982, order 1
2025-09-13 16:42:01,977 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:42:01,981 - jwst.photom.photom - INFO - Working on slit 1364, order 1
2025-09-13 16:42:01,982 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:42:01,985 - jwst.photom.photom - INFO - Working on slit 898, order 1
2025-09-13 16:42:01,986 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:42:01,989 - jwst.photom.photom - INFO - Working on slit 1049, order 1
2025-09-13 16:42:01,990 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:42:01,993 - jwst.photom.photom - INFO - Working on slit 732, order 1
2025-09-13 16:42:01,994 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:42:01,998 - jwst.photom.photom - INFO - Working on slit 189, order 1
2025-09-13 16:42:01,999 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:42:02,002 - jwst.photom.photom - INFO - Working on slit 881, order 1
2025-09-13 16:42:02,003 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:42:02,006 - jwst.photom.photom - INFO - Working on slit 966, order 1
2025-09-13 16:42:02,007 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:42:02,011 - jwst.photom.photom - INFO - Working on slit 914, order 1
2025-09-13 16:42:02,011 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:42:02,015 - jwst.photom.photom - INFO - Working on slit 1084, order 1
2025-09-13 16:42:02,016 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:42:02,019 - jwst.photom.photom - INFO - Working on slit 540, order 1
2025-09-13 16:42:02,020 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:42:02,024 - jwst.photom.photom - INFO - Working on slit 1476, order 1
2025-09-13 16:42:02,024 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:42:02,027 - jwst.photom.photom - INFO - Working on slit 1142, order 1
2025-09-13 16:42:02,028 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:42:02,032 - jwst.photom.photom - INFO - Working on slit 220, order 1
2025-09-13 16:42:02,033 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:42:02,036 - jwst.photom.photom - INFO - Working on slit 289, order 1
2025-09-13 16:42:02,037 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:42:02,040 - jwst.photom.photom - INFO - Working on slit 934, order 1
2025-09-13 16:42:02,041 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:42:02,045 - jwst.photom.photom - INFO - Working on slit 1219, order 1
2025-09-13 16:42:02,045 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:42:02,049 - jwst.photom.photom - INFO - Working on slit 927, order 1
2025-09-13 16:42:02,050 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:42:02,053 - jwst.photom.photom - INFO - Working on slit 1417, order 1
2025-09-13 16:42:02,054 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:42:02,057 - jwst.photom.photom - INFO - Working on slit 567, order 1
2025-09-13 16:42:02,058 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:42:02,062 - jwst.photom.photom - INFO - Working on slit 1296, order 1
2025-09-13 16:42:02,063 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:42:02,066 - jwst.photom.photom - INFO - Working on slit 1412, order 1
2025-09-13 16:42:02,067 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:42:02,070 - jwst.photom.photom - INFO - Working on slit 654, order 1
2025-09-13 16:42:02,071 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:42:02,075 - jwst.photom.photom - INFO - Working on slit 1029, order 1
2025-09-13 16:42:02,075 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:42:02,079 - jwst.photom.photom - INFO - Working on slit 553, order 1
2025-09-13 16:42:02,080 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:42:02,083 - jwst.photom.photom - INFO - Working on slit 1387, order 1
2025-09-13 16:42:02,084 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:42:02,088 - jwst.photom.photom - INFO - Working on slit 422, order 1
2025-09-13 16:42:02,088 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:42:02,092 - jwst.photom.photom - INFO - Working on slit 821, order 1
2025-09-13 16:42:02,092 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:42:02,096 - jwst.photom.photom - INFO - Working on slit 682, order 1
2025-09-13 16:42:02,097 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:42:02,100 - jwst.photom.photom - INFO - Working on slit 1140, order 1
2025-09-13 16:42:02,101 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:42:02,104 - jwst.photom.photom - INFO - Working on slit 1388, order 1
2025-09-13 16:42:02,105 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:42:02,109 - jwst.photom.photom - INFO - Working on slit 759, order 1
2025-09-13 16:42:02,109 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:42:02,113 - jwst.photom.photom - INFO - Working on slit 1407, order 1
2025-09-13 16:42:02,113 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:42:02,117 - jwst.photom.photom - INFO - Working on slit 1194, order 1
2025-09-13 16:42:02,118 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:42:02,121 - jwst.photom.photom - INFO - Working on slit 712, order 1
2025-09-13 16:42:02,122 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:42:02,125 - jwst.photom.photom - INFO - Working on slit 539, order 1
2025-09-13 16:42:02,126 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:42:02,129 - jwst.photom.photom - INFO - Working on slit 1008, order 1
2025-09-13 16:42:02,130 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:42:02,134 - jwst.photom.photom - INFO - Working on slit 347, order 1
2025-09-13 16:42:02,134 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:42:02,138 - jwst.photom.photom - INFO - Working on slit 276, order 1
2025-09-13 16:42:02,138 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:42:02,142 - jwst.photom.photom - INFO - Working on slit 605, order 1
2025-09-13 16:42:02,143 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:42:02,146 - jwst.photom.photom - INFO - Working on slit 922, order 1
2025-09-13 16:42:02,147 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:42:02,151 - jwst.photom.photom - INFO - Working on slit 736, order 1
2025-09-13 16:42:02,151 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:42:02,155 - jwst.photom.photom - INFO - Working on slit 1423, order 1
2025-09-13 16:42:02,155 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:42:02,159 - jwst.photom.photom - INFO - Working on slit 800, order 1
2025-09-13 16:42:02,160 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:42:02,163 - jwst.photom.photom - INFO - Working on slit 873, order 1
2025-09-13 16:42:02,164 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:42:02,167 - jwst.photom.photom - INFO - Working on slit 385, order 1
2025-09-13 16:42:02,168 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:42:02,171 - jwst.photom.photom - INFO - Working on slit 557, order 1
2025-09-13 16:42:02,172 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:42:02,176 - jwst.photom.photom - INFO - Working on slit 719, order 1
2025-09-13 16:42:02,176 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:42:02,180 - jwst.photom.photom - INFO - Working on slit 389, order 1
2025-09-13 16:42:02,181 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:42:02,184 - jwst.photom.photom - INFO - Working on slit 733, order 1
2025-09-13 16:42:02,185 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:42:02,189 - jwst.photom.photom - INFO - Working on slit 1442, order 1
2025-09-13 16:42:02,189 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:42:02,193 - jwst.photom.photom - INFO - Working on slit 417, order 1
2025-09-13 16:42:02,193 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:42:02,197 - jwst.photom.photom - INFO - Working on slit 630, order 1
2025-09-13 16:42:02,198 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:42:02,201 - jwst.photom.photom - INFO - Working on slit 925, order 1
2025-09-13 16:42:02,202 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:42:02,205 - jwst.photom.photom - INFO - Working on slit 527, order 1
2025-09-13 16:42:02,206 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:42:02,209 - jwst.photom.photom - INFO - Working on slit 439, order 1
2025-09-13 16:42:02,210 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:42:02,214 - jwst.photom.photom - INFO - Working on slit 1253, order 1
2025-09-13 16:42:02,214 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:42:02,218 - jwst.photom.photom - INFO - Working on slit 1162, order 1
2025-09-13 16:42:02,218 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:42:02,222 - jwst.photom.photom - INFO - Working on slit 1457, order 1
2025-09-13 16:42:02,222 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:42:02,226 - jwst.photom.photom - INFO - Working on slit 694, order 1
2025-09-13 16:42:02,227 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:42:02,230 - jwst.photom.photom - INFO - Working on slit 1266, order 1
2025-09-13 16:42:02,231 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:42:02,234 - jwst.photom.photom - INFO - Working on slit 298, order 1
2025-09-13 16:42:02,235 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:42:02,238 - jwst.photom.photom - INFO - Working on slit 516, order 1
2025-09-13 16:42:02,239 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:42:02,242 - jwst.photom.photom - INFO - Working on slit 973, order 1
2025-09-13 16:42:02,243 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:42:02,246 - jwst.photom.photom - INFO - Working on slit 180, order 1
2025-09-13 16:42:02,247 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:42:02,251 - jwst.photom.photom - INFO - Working on slit 980, order 1
2025-09-13 16:42:02,251 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:42:02,255 - jwst.photom.photom - INFO - Working on slit 263, order 1
2025-09-13 16:42:02,255 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:42:02,259 - jwst.photom.photom - INFO - Working on slit 493, order 1
2025-09-13 16:42:02,260 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:42:02,263 - jwst.photom.photom - INFO - Working on slit 981, order 1
2025-09-13 16:42:02,264 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:42:02,267 - jwst.photom.photom - INFO - Working on slit 1371, order 1
2025-09-13 16:42:02,268 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:42:02,271 - jwst.photom.photom - INFO - Working on slit 536, order 1
2025-09-13 16:42:02,272 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:42:02,275 - jwst.photom.photom - INFO - Working on slit 749, order 1
2025-09-13 16:42:02,276 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:42:02,280 - jwst.photom.photom - INFO - Working on slit 345, order 1
2025-09-13 16:42:02,280 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:42:02,284 - jwst.photom.photom - INFO - Working on slit 721, order 1
2025-09-13 16:42:02,284 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:42:02,288 - jwst.photom.photom - INFO - Working on slit 387, order 1
2025-09-13 16:42:02,289 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:42:02,292 - jwst.photom.photom - INFO - Working on slit 505, order 1
2025-09-13 16:42:02,293 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:42:02,296 - jwst.photom.photom - INFO - Working on slit 566, order 1
2025-09-13 16:42:02,297 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:42:02,300 - jwst.photom.photom - INFO - Working on slit 772, order 1
2025-09-13 16:42:02,301 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:42:02,305 - jwst.photom.photom - INFO - Working on slit 722, order 1
2025-09-13 16:42:02,305 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:42:02,309 - jwst.photom.photom - INFO - Working on slit 872, order 1
2025-09-13 16:42:02,309 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:42:02,313 - jwst.photom.photom - INFO - Working on slit 933, order 1
2025-09-13 16:42:02,314 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:42:02,317 - jwst.photom.photom - INFO - Working on slit 1128, order 1
2025-09-13 16:42:02,318 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:42:02,321 - jwst.photom.photom - INFO - Working on slit 1282, order 1
2025-09-13 16:42:02,322 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:42:02,325 - jwst.photom.photom - INFO - Working on slit 274, order 1
2025-09-13 16:42:02,326 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:42:02,329 - jwst.photom.photom - INFO - Working on slit 124, order 1
2025-09-13 16:42:02,330 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:42:02,334 - jwst.photom.photom - INFO - Working on slit 641, order 1
2025-09-13 16:42:02,334 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:42:02,338 - jwst.photom.photom - INFO - Working on slit 543, order 1
2025-09-13 16:42:02,338 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:42:02,342 - jwst.photom.photom - INFO - Working on slit 610, order 1
2025-09-13 16:42:02,343 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:42:02,346 - jwst.photom.photom - INFO - Working on slit 1188, order 1
2025-09-13 16:42:02,346 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:42:02,350 - jwst.photom.photom - INFO - Working on slit 533, order 1
2025-09-13 16:42:02,351 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:42:02,358 - stpipe.Spec2Pipeline.photom - INFO - Step photom done
2025-09-13 16:42:05,439 - stpipe.Spec2Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<MultiSlitModel from /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage2_spec/jw02079004003_05101_00002_nis_cal.fits>,).
2025-09-13 16:42:05,440 - stpipe.Spec2Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 16:42:08,436 - stpipe.Spec2Pipeline.extract_1d - INFO - Step extract_1d running with args (<MultiSlitModel from /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage2_spec/jw02079004003_05101_00002_nis_cal.fits>,).
2025-09-13 16:42:08,560 - stpipe.Spec2Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 16:42:08,611 - jwst.extract_1d.extract - INFO - Working on slit 522
2025-09-13 16:42:08,613 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:42:08,614 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 147.00 (inclusive)
2025-09-13 16:42:08,669 - jwst.extract_1d.extract - INFO - Working on slit 796
2025-09-13 16:42:08,670 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:42:08,671 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 95.00 (inclusive)
2025-09-13 16:42:08,725 - jwst.extract_1d.extract - INFO - Working on slit 1479
2025-09-13 16:42:08,726 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:42:08,727 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 22.00 (inclusive)
2025-09-13 16:42:08,780 - jwst.extract_1d.extract - INFO - Working on slit 214
2025-09-13 16:42:08,782 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:42:08,782 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 105.00 (inclusive)
2025-09-13 16:42:08,835 - jwst.extract_1d.extract - INFO - Working on slit 693
2025-09-13 16:42:08,836 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:42:08,837 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 75.00 (inclusive)
2025-09-13 16:42:08,888 - jwst.extract_1d.extract - INFO - Working on slit 1120
2025-09-13 16:42:08,889 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:42:08,890 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 67.00 (inclusive)
2025-09-13 16:42:08,941 - jwst.extract_1d.extract - INFO - Working on slit 1257
2025-09-13 16:42:08,942 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:42:08,943 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 76.00 (inclusive)
2025-09-13 16:42:08,995 - jwst.extract_1d.extract - INFO - Working on slit 766
2025-09-13 16:42:08,996 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:42:08,996 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 102.00 (inclusive)
2025-09-13 16:42:09,048 - jwst.extract_1d.extract - INFO - Working on slit 606
2025-09-13 16:42:09,048 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type POINT
2025-09-13 16:42:09,049 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 10.00 (inclusive)
2025-09-13 16:42:09,056 - jwst.extract_1d.extract - INFO - Creating aperture correction.
2025-09-13 16:42:09,194 - jwst.extract_1d.extract - INFO - Working on slit 649
2025-09-13 16:42:09,195 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:42:09,196 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 94.00 (inclusive)
2025-09-13 16:42:09,251 - jwst.extract_1d.extract - INFO - Working on slit 982
2025-09-13 16:42:09,252 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:42:09,253 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 55.00 (inclusive)
2025-09-13 16:42:09,305 - jwst.extract_1d.extract - INFO - Working on slit 1364
2025-09-13 16:42:09,306 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:42:09,307 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 60.00 (inclusive)
2025-09-13 16:42:09,360 - jwst.extract_1d.extract - INFO - Working on slit 898
2025-09-13 16:42:09,361 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type POINT
2025-09-13 16:42:09,362 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 10.00 (inclusive)
2025-09-13 16:42:09,369 - jwst.extract_1d.extract - INFO - Creating aperture correction.
2025-09-13 16:42:09,498 - jwst.extract_1d.extract - INFO - Working on slit 1049
2025-09-13 16:42:09,499 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:42:09,500 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 75.00 (inclusive)
2025-09-13 16:42:09,554 - jwst.extract_1d.extract - INFO - Working on slit 732
2025-09-13 16:42:09,555 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:42:09,557 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 44.00 (inclusive)
2025-09-13 16:42:09,610 - jwst.extract_1d.extract - INFO - Working on slit 189
2025-09-13 16:42:09,611 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:42:09,612 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 46.00 (inclusive)
2025-09-13 16:42:09,666 - jwst.extract_1d.extract - INFO - Working on slit 881
2025-09-13 16:42:09,667 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type POINT
2025-09-13 16:42:09,668 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 10.00 (inclusive)
2025-09-13 16:42:09,675 - jwst.extract_1d.extract - INFO - Creating aperture correction.
2025-09-13 16:42:09,816 - jwst.extract_1d.extract - INFO - Working on slit 966
2025-09-13 16:42:09,817 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:42:09,818 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 59.00 (inclusive)
2025-09-13 16:42:09,871 - jwst.extract_1d.extract - INFO - Working on slit 914
2025-09-13 16:42:09,872 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:42:09,873 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 31.00 (inclusive)
2025-09-13 16:42:09,927 - jwst.extract_1d.extract - INFO - Working on slit 1084
2025-09-13 16:42:09,928 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type POINT
2025-09-13 16:42:09,929 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 10.00 (inclusive)
2025-09-13 16:42:09,936 - jwst.extract_1d.extract - INFO - Creating aperture correction.
2025-09-13 16:42:10,069 - jwst.extract_1d.extract - INFO - Working on slit 540
2025-09-13 16:42:10,071 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:42:10,072 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 71.00 (inclusive)
2025-09-13 16:42:10,124 - jwst.extract_1d.extract - INFO - Working on slit 1476
2025-09-13 16:42:10,125 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:42:10,126 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 24.00 (inclusive)
2025-09-13 16:42:10,178 - jwst.extract_1d.extract - INFO - Working on slit 1142
2025-09-13 16:42:10,179 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:42:10,180 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 46.00 (inclusive)
2025-09-13 16:42:10,231 - jwst.extract_1d.extract - INFO - Working on slit 220
2025-09-13 16:42:10,232 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type POINT
2025-09-13 16:42:10,233 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 10.00 (inclusive)
2025-09-13 16:42:10,240 - jwst.extract_1d.extract - INFO - Creating aperture correction.
2025-09-13 16:42:10,370 - jwst.extract_1d.extract - INFO - Working on slit 289
2025-09-13 16:42:10,371 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:42:10,372 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 35.00 (inclusive)
2025-09-13 16:42:10,428 - jwst.extract_1d.extract - INFO - Working on slit 934
2025-09-13 16:42:10,429 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:42:10,430 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 46.00 (inclusive)
2025-09-13 16:42:10,484 - jwst.extract_1d.extract - INFO - Working on slit 1219
2025-09-13 16:42:10,485 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:42:10,486 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 60.00 (inclusive)
2025-09-13 16:42:10,539 - jwst.extract_1d.extract - INFO - Working on slit 927
2025-09-13 16:42:10,540 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:42:10,541 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 44.00 (inclusive)
2025-09-13 16:42:10,596 - jwst.extract_1d.extract - INFO - Working on slit 1417
2025-09-13 16:42:10,597 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:42:10,598 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 37.00 (inclusive)
2025-09-13 16:42:10,652 - jwst.extract_1d.extract - INFO - Working on slit 567
2025-09-13 16:42:10,653 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:42:10,654 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 48.00 (inclusive)
2025-09-13 16:42:10,706 - jwst.extract_1d.extract - INFO - Working on slit 1296
2025-09-13 16:42:10,707 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:42:10,708 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 43.00 (inclusive)
2025-09-13 16:42:10,761 - jwst.extract_1d.extract - INFO - Working on slit 1412
2025-09-13 16:42:10,762 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:42:10,763 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 39.00 (inclusive)
2025-09-13 16:42:10,816 - jwst.extract_1d.extract - INFO - Working on slit 654
2025-09-13 16:42:10,817 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:42:10,818 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 59.00 (inclusive)
2025-09-13 16:42:10,870 - jwst.extract_1d.extract - INFO - Working on slit 1029
2025-09-13 16:42:10,871 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:42:10,872 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 56.00 (inclusive)
2025-09-13 16:42:10,925 - jwst.extract_1d.extract - INFO - Working on slit 553
2025-09-13 16:42:10,926 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:42:10,927 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 35.00 (inclusive)
2025-09-13 16:42:10,980 - jwst.extract_1d.extract - INFO - Working on slit 1387
2025-09-13 16:42:10,981 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:42:10,982 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 40.00 (inclusive)
2025-09-13 16:42:11,034 - jwst.extract_1d.extract - INFO - Working on slit 422
2025-09-13 16:42:11,035 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:42:11,036 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 28.00 (inclusive)
2025-09-13 16:42:11,090 - jwst.extract_1d.extract - INFO - Working on slit 821
2025-09-13 16:42:11,091 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:42:11,092 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 42.00 (inclusive)
2025-09-13 16:42:11,145 - jwst.extract_1d.extract - INFO - Working on slit 682
2025-09-13 16:42:11,146 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:42:11,146 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 50.00 (inclusive)
2025-09-13 16:42:11,199 - jwst.extract_1d.extract - INFO - Working on slit 1140
2025-09-13 16:42:11,200 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:42:11,201 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 42.00 (inclusive)
2025-09-13 16:42:11,255 - jwst.extract_1d.extract - INFO - Working on slit 1388
2025-09-13 16:42:11,256 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:42:11,257 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 58.00 (inclusive)
2025-09-13 16:42:11,310 - jwst.extract_1d.extract - INFO - Working on slit 759
2025-09-13 16:42:11,311 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:42:11,312 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 40.00 (inclusive)
2025-09-13 16:42:11,364 - jwst.extract_1d.extract - INFO - Working on slit 1407
2025-09-13 16:42:11,365 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:42:11,366 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 35.00 (inclusive)
2025-09-13 16:42:11,419 - jwst.extract_1d.extract - INFO - Working on slit 1194
2025-09-13 16:42:11,420 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:42:11,421 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 29.00 (inclusive)
2025-09-13 16:42:11,473 - jwst.extract_1d.extract - INFO - Working on slit 712
2025-09-13 16:42:11,474 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:42:11,474 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 34.00 (inclusive)
2025-09-13 16:42:11,526 - jwst.extract_1d.extract - INFO - Working on slit 539
2025-09-13 16:42:11,527 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:42:11,528 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 42.00 (inclusive)
2025-09-13 16:42:11,580 - jwst.extract_1d.extract - INFO - Working on slit 1008
2025-09-13 16:42:11,581 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:42:11,582 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 30.00 (inclusive)
2025-09-13 16:42:11,633 - jwst.extract_1d.extract - INFO - Working on slit 347
2025-09-13 16:42:11,634 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type POINT
2025-09-13 16:42:11,635 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 10.00 (inclusive)
2025-09-13 16:42:11,642 - jwst.extract_1d.extract - INFO - Creating aperture correction.
2025-09-13 16:42:11,762 - jwst.extract_1d.extract - INFO - Working on slit 276
2025-09-13 16:42:11,763 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:42:11,764 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 44.00 (inclusive)
2025-09-13 16:42:11,817 - jwst.extract_1d.extract - INFO - Working on slit 605
2025-09-13 16:42:11,818 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type POINT
2025-09-13 16:42:11,819 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 10.00 (inclusive)
2025-09-13 16:42:11,825 - jwst.extract_1d.extract - INFO - Creating aperture correction.
2025-09-13 16:42:11,942 - jwst.extract_1d.extract - INFO - Working on slit 922
2025-09-13 16:42:11,943 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:42:11,944 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 29.00 (inclusive)
2025-09-13 16:42:11,997 - jwst.extract_1d.extract - INFO - Working on slit 736
2025-09-13 16:42:11,998 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:42:11,999 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 22.00 (inclusive)
2025-09-13 16:42:12,053 - jwst.extract_1d.extract - INFO - Working on slit 1423
2025-09-13 16:42:12,054 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:42:12,055 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 31.00 (inclusive)
2025-09-13 16:42:12,107 - jwst.extract_1d.extract - INFO - Working on slit 800
2025-09-13 16:42:12,108 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:42:12,109 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 26.00 (inclusive)
2025-09-13 16:42:12,161 - jwst.extract_1d.extract - INFO - Working on slit 873
2025-09-13 16:42:12,162 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:42:12,163 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 27.00 (inclusive)
2025-09-13 16:42:12,216 - jwst.extract_1d.extract - INFO - Working on slit 385
2025-09-13 16:42:12,217 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:42:12,218 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 20.00 (inclusive)
2025-09-13 16:42:12,270 - jwst.extract_1d.extract - INFO - Working on slit 557
2025-09-13 16:42:12,271 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:42:12,272 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 37.00 (inclusive)
2025-09-13 16:42:12,325 - jwst.extract_1d.extract - INFO - Working on slit 719
2025-09-13 16:42:12,326 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:42:12,327 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 29.00 (inclusive)
2025-09-13 16:42:12,380 - jwst.extract_1d.extract - INFO - Working on slit 389
2025-09-13 16:42:12,381 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:42:12,382 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 30.00 (inclusive)
2025-09-13 16:42:12,435 - jwst.extract_1d.extract - INFO - Working on slit 733
2025-09-13 16:42:12,436 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:42:12,437 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 43.00 (inclusive)
2025-09-13 16:42:12,489 - jwst.extract_1d.extract - INFO - Working on slit 1442
2025-09-13 16:42:12,490 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:42:12,491 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 43.00 (inclusive)
2025-09-13 16:42:12,544 - jwst.extract_1d.extract - INFO - Working on slit 417
2025-09-13 16:42:12,545 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:42:12,545 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 29.00 (inclusive)
2025-09-13 16:42:12,598 - jwst.extract_1d.extract - INFO - Working on slit 630
2025-09-13 16:42:12,598 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type POINT
2025-09-13 16:42:12,599 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 10.00 (inclusive)
2025-09-13 16:42:12,606 - jwst.extract_1d.extract - INFO - Creating aperture correction.
2025-09-13 16:42:12,721 - jwst.extract_1d.extract - INFO - Working on slit 925
2025-09-13 16:42:12,722 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:42:12,723 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 32.00 (inclusive)
2025-09-13 16:42:12,775 - jwst.extract_1d.extract - INFO - Working on slit 527
2025-09-13 16:42:12,776 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:42:12,777 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 35.00 (inclusive)
2025-09-13 16:42:12,829 - jwst.extract_1d.extract - INFO - Working on slit 439
2025-09-13 16:42:12,830 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type POINT
2025-09-13 16:42:12,831 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 10.00 (inclusive)
2025-09-13 16:42:12,837 - jwst.extract_1d.extract - INFO - Creating aperture correction.
2025-09-13 16:42:12,961 - jwst.extract_1d.extract - INFO - Working on slit 1253
2025-09-13 16:42:12,962 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:42:12,963 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 32.00 (inclusive)
2025-09-13 16:42:13,016 - jwst.extract_1d.extract - INFO - Working on slit 1162
2025-09-13 16:42:13,018 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:42:13,018 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 18.00 (inclusive)
2025-09-13 16:42:13,071 - jwst.extract_1d.extract - INFO - Working on slit 1457
2025-09-13 16:42:13,072 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:42:13,073 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 24.00 (inclusive)
2025-09-13 16:42:13,124 - jwst.extract_1d.extract - INFO - Working on slit 694
2025-09-13 16:42:13,126 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:42:13,126 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 22.00 (inclusive)
2025-09-13 16:42:13,179 - jwst.extract_1d.extract - INFO - Working on slit 1266
2025-09-13 16:42:13,180 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:42:13,181 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 26.00 (inclusive)
2025-09-13 16:42:13,232 - jwst.extract_1d.extract - INFO - Working on slit 298
2025-09-13 16:42:13,233 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:42:13,234 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 22.00 (inclusive)
2025-09-13 16:42:13,287 - jwst.extract_1d.extract - INFO - Working on slit 516
2025-09-13 16:42:13,288 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:42:13,289 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 33.00 (inclusive)
2025-09-13 16:42:13,341 - jwst.extract_1d.extract - INFO - Working on slit 973
2025-09-13 16:42:13,342 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:42:13,343 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 20.00 (inclusive)
2025-09-13 16:42:13,394 - jwst.extract_1d.extract - INFO - Working on slit 180
2025-09-13 16:42:13,395 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:42:13,396 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 32.00 (inclusive)
2025-09-13 16:42:13,447 - jwst.extract_1d.extract - INFO - Working on slit 980
2025-09-13 16:42:13,448 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:42:13,449 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 30.00 (inclusive)
2025-09-13 16:42:13,501 - jwst.extract_1d.extract - INFO - Working on slit 263
2025-09-13 16:42:13,502 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:42:13,503 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 24.00 (inclusive)
2025-09-13 16:42:13,555 - jwst.extract_1d.extract - INFO - Working on slit 493
2025-09-13 16:42:13,556 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:42:13,557 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 30.00 (inclusive)
2025-09-13 16:42:13,608 - jwst.extract_1d.extract - INFO - Working on slit 981
2025-09-13 16:42:13,609 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:42:13,610 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 23.00 (inclusive)
2025-09-13 16:42:13,662 - jwst.extract_1d.extract - INFO - Working on slit 1371
2025-09-13 16:42:13,663 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:42:13,664 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 22.00 (inclusive)
2025-09-13 16:42:13,716 - jwst.extract_1d.extract - INFO - Working on slit 536
2025-09-13 16:42:13,717 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:42:13,718 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 33.00 (inclusive)
2025-09-13 16:42:13,770 - jwst.extract_1d.extract - INFO - Working on slit 749
2025-09-13 16:42:13,771 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:42:13,772 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 22.00 (inclusive)
2025-09-13 16:42:13,826 - jwst.extract_1d.extract - INFO - Working on slit 345
2025-09-13 16:42:13,827 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:42:13,827 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 21.00 (inclusive)
2025-09-13 16:42:13,880 - jwst.extract_1d.extract - INFO - Working on slit 721
2025-09-13 16:42:13,881 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type POINT
2025-09-13 16:42:13,881 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 10.00 (inclusive)
2025-09-13 16:42:13,890 - jwst.extract_1d.extract - INFO - Creating aperture correction.
2025-09-13 16:42:14,006 - jwst.extract_1d.extract - INFO - Working on slit 387
2025-09-13 16:42:14,007 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:42:14,008 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 19.00 (inclusive)
2025-09-13 16:42:14,062 - jwst.extract_1d.extract - INFO - Working on slit 505
2025-09-13 16:42:14,063 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:42:14,064 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 21.00 (inclusive)
2025-09-13 16:42:14,116 - jwst.extract_1d.extract - INFO - Working on slit 566
2025-09-13 16:42:14,117 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:42:14,118 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 36.00 (inclusive)
2025-09-13 16:42:14,171 - jwst.extract_1d.extract - INFO - Working on slit 772
2025-09-13 16:42:14,172 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:42:14,173 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 25.00 (inclusive)
2025-09-13 16:42:14,227 - jwst.extract_1d.extract - INFO - Working on slit 722
2025-09-13 16:42:14,228 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:42:14,229 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 27.00 (inclusive)
2025-09-13 16:42:14,281 - jwst.extract_1d.extract - INFO - Working on slit 872
2025-09-13 16:42:14,281 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type POINT
2025-09-13 16:42:14,282 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 10.00 (inclusive)
2025-09-13 16:42:14,289 - jwst.extract_1d.extract - INFO - Creating aperture correction.
2025-09-13 16:42:14,407 - jwst.extract_1d.extract - INFO - Working on slit 933
2025-09-13 16:42:14,408 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:42:14,409 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 24.00 (inclusive)
2025-09-13 16:42:14,461 - jwst.extract_1d.extract - INFO - Working on slit 1128
2025-09-13 16:42:14,462 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type POINT
2025-09-13 16:42:14,463 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 10.00 (inclusive)
2025-09-13 16:42:14,469 - jwst.extract_1d.extract - INFO - Creating aperture correction.
2025-09-13 16:42:14,582 - jwst.extract_1d.extract - INFO - Working on slit 1282
2025-09-13 16:42:14,583 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:42:14,584 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 34.00 (inclusive)
2025-09-13 16:42:14,636 - jwst.extract_1d.extract - INFO - Working on slit 274
2025-09-13 16:42:14,637 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:42:14,638 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 31.00 (inclusive)
2025-09-13 16:42:14,689 - jwst.extract_1d.extract - INFO - Working on slit 124
2025-09-13 16:42:14,690 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:42:14,691 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 6.00 (inclusive)
2025-09-13 16:42:14,741 - jwst.extract_1d.extract - INFO - Working on slit 641
2025-09-13 16:42:14,742 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:42:14,743 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 23.00 (inclusive)
2025-09-13 16:42:14,794 - jwst.extract_1d.extract - INFO - Working on slit 543
2025-09-13 16:42:14,795 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:42:14,796 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 29.00 (inclusive)
2025-09-13 16:42:14,847 - jwst.extract_1d.extract - INFO - Working on slit 610
2025-09-13 16:42:14,848 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type POINT
2025-09-13 16:42:14,848 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 10.00 (inclusive)
2025-09-13 16:42:14,855 - jwst.extract_1d.extract - INFO - Creating aperture correction.
2025-09-13 16:42:14,915 - jwst.extract_1d.extract - INFO - Working on slit 1188
2025-09-13 16:42:14,916 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:42:14,917 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 38.00 (inclusive)
2025-09-13 16:42:14,968 - jwst.extract_1d.extract - INFO - Working on slit 533
2025-09-13 16:42:14,969 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:42:14,969 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 21.00 (inclusive)
2025-09-13 16:42:15,281 - stpipe.Spec2Pipeline.extract_1d - INFO - Saved model in /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage2_spec/jw02079004003_05101_00002_nis_x1d.fits
2025-09-13 16:42:15,282 - stpipe.Spec2Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 16:42:15,285 - stpipe.Spec2Pipeline - INFO - Finished processing product /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage1/jw02079004003_05101_00002_nis
2025-09-13 16:42:15,288 - stpipe.Spec2Pipeline - INFO - Ending calwebb_spec2
2025-09-13 16:42:15,289 - jwst.stpipe.core - INFO - Results used CRDS context: jwst_1413.pmap
2025-09-13 16:42:26,848 - stpipe.Spec2Pipeline - INFO - Saved model in /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage2_spec/jw02079004003_05101_00002_nis_cal.fits
2025-09-13 16:42:26,848 - stpipe.Spec2Pipeline - INFO - Step Spec2Pipeline done
2025-09-13 16:42:26,849 - jwst.stpipe.core - INFO - Results used jwst version: 1.19.1
2025-09-13 16:42:26,861 - py.warnings - WARNING - /usr/share/miniconda/lib/python3.13/site-packages/jwst/associations/association.py:234: UserWarning: Input association file contains path information; note that this can complicate usage and/or sharing of such files.
warnings.warn(err_str, UserWarning, stacklevel=1)
2025-09-13 16:42:26,918 - stpipe - INFO - PARS-SPEC2PIPELINE parameters found: /home/runner/crds/references/jwst/niriss/jwst_niriss_pars-spec2pipeline_0005.asdf
2025-09-13 16:42:26,940 - stpipe.Spec2Pipeline - INFO - Spec2Pipeline instance created.
2025-09-13 16:42:26,941 - stpipe.Spec2Pipeline.assign_wcs - INFO - AssignWcsStep instance created.
2025-09-13 16:42:26,942 - stpipe.Spec2Pipeline.badpix_selfcal - INFO - BadpixSelfcalStep instance created.
2025-09-13 16:42:26,943 - stpipe.Spec2Pipeline.msa_flagging - INFO - MSAFlagOpenStep instance created.
2025-09-13 16:42:26,944 - stpipe.Spec2Pipeline.nsclean - INFO - NSCleanStep instance created.
2025-09-13 16:42:26,945 - stpipe.Spec2Pipeline.bkg_subtract - INFO - BackgroundStep instance created.
2025-09-13 16:42:26,946 - stpipe.Spec2Pipeline.imprint_subtract - INFO - ImprintStep instance created.
2025-09-13 16:42:26,947 - stpipe.Spec2Pipeline.extract_2d - INFO - Extract2dStep instance created.
2025-09-13 16:42:26,951 - stpipe.Spec2Pipeline.master_background_mos - INFO - MasterBackgroundMosStep instance created.
2025-09-13 16:42:26,952 - stpipe.Spec2Pipeline.master_background_mos.flat_field - INFO - FlatFieldStep instance created.
2025-09-13 16:42:26,953 - stpipe.Spec2Pipeline.master_background_mos.pathloss - INFO - PathLossStep instance created.
2025-09-13 16:42:26,953 - stpipe.Spec2Pipeline.master_background_mos.barshadow - INFO - BarShadowStep instance created.
2025-09-13 16:42:26,954 - stpipe.Spec2Pipeline.master_background_mos.photom - INFO - PhotomStep instance created.
2025-09-13 16:42:26,955 - stpipe.Spec2Pipeline.master_background_mos.pixel_replace - INFO - PixelReplaceStep instance created.
2025-09-13 16:42:26,956 - stpipe.Spec2Pipeline.master_background_mos.resample_spec - INFO - ResampleSpecStep instance created.
2025-09-13 16:42:26,957 - stpipe.Spec2Pipeline.master_background_mos.extract_1d - INFO - Extract1dStep instance created.
2025-09-13 16:42:26,958 - stpipe.Spec2Pipeline.wavecorr - INFO - WavecorrStep instance created.
2025-09-13 16:42:26,959 - stpipe.Spec2Pipeline.flat_field - INFO - FlatFieldStep instance created.
2025-09-13 16:42:26,960 - stpipe.Spec2Pipeline.srctype - INFO - SourceTypeStep instance created.
2025-09-13 16:42:26,961 - stpipe.Spec2Pipeline.straylight - INFO - StraylightStep instance created.
2025-09-13 16:42:26,962 - stpipe.Spec2Pipeline.fringe - INFO - FringeStep instance created.
2025-09-13 16:42:26,962 - stpipe.Spec2Pipeline.residual_fringe - INFO - ResidualFringeStep instance created.
2025-09-13 16:42:26,963 - stpipe.Spec2Pipeline.pathloss - INFO - PathLossStep instance created.
2025-09-13 16:42:26,964 - stpipe.Spec2Pipeline.barshadow - INFO - BarShadowStep instance created.
2025-09-13 16:42:26,965 - stpipe.Spec2Pipeline.wfss_contam - INFO - WfssContamStep instance created.
2025-09-13 16:42:26,965 - stpipe.Spec2Pipeline.photom - INFO - PhotomStep instance created.
2025-09-13 16:42:26,967 - stpipe.Spec2Pipeline.pixel_replace - INFO - PixelReplaceStep instance created.
2025-09-13 16:42:26,968 - stpipe.Spec2Pipeline.resample_spec - INFO - ResampleSpecStep instance created.
2025-09-13 16:42:26,969 - stpipe.Spec2Pipeline.cube_build - INFO - CubeBuildStep instance created.
2025-09-13 16:42:26,970 - stpipe.Spec2Pipeline.extract_1d - INFO - Extract1dStep instance created.
2025-09-13 16:42:27,706 - stpipe.Spec2Pipeline - INFO - Step Spec2Pipeline running with args ('/home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/jw02079004003_05101_00003_nis_spec2_asn.json',).
2025-09-13 16:42:27,740 - stpipe.Spec2Pipeline - INFO - Step Spec2Pipeline parameters are:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage2_spec
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: True
skip: False
suffix: None
search_output_file: True
input_dir: ''
save_bsub: False
fail_on_exception: True
save_wfss_esec: False
steps:
assign_wcs:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
sip_approx: True
sip_max_pix_error: 0.01
sip_degree: None
sip_max_inv_pix_error: 0.01
sip_inv_degree: None
sip_npoints: 12
slit_y_low: -0.55
slit_y_high: 0.55
nrs_ifu_slice_wcs: False
badpix_selfcal:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: True
suffix: None
search_output_file: True
input_dir: ''
flagfrac_lower: 0.001
flagfrac_upper: 0.001
kernel_size: 15
force_single: False
save_flagged_bkg: False
msa_flagging:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
nsclean:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: True
suffix: None
search_output_file: True
input_dir: ''
fit_method: fft
fit_by_channel: False
background_method: None
background_box_size: None
mask_spectral_regions: True
n_sigma: 5.0
fit_histogram: False
single_mask: False
user_mask: None
save_mask: False
save_background: False
save_noise: False
bkg_subtract:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
bkg_list: None
save_combined_background: False
sigma: 3.0
maxiters: None
soss_source_percentile: 35.0
soss_bkg_percentile: None
wfss_mmag_extract: None
wfss_maxiter: 5
wfss_rms_stop: 0.0
wfss_outlier_percent: 1.0
imprint_subtract:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
extract_2d:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
slit_names: None
source_ids: None
extract_orders: None
grism_objects: None
tsgrism_extract_height: None
wfss_extract_half_height: 5
wfss_mmag_extract: None
wfss_nbright: 100
master_background_mos:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: True
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
sigma_clip: 3.0
median_kernel: 1
force_subtract: False
save_background: False
user_background: None
inverse: False
steps:
flat_field:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
save_interpolated_flat: False
user_supplied_flat: None
inverse: False
pathloss:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
inverse: False
source_type: None
user_slit_loc: None
barshadow:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
inverse: False
source_type: None
photom:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
inverse: False
source_type: None
mrs_time_correction: True
pixel_replace:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: True
output_use_index: True
save_results: False
skip: True
suffix: None
search_output_file: True
input_dir: ''
algorithm: fit_profile
n_adjacent_cols: 3
resample_spec:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
pixfrac: 1.0
kernel: square
fillval: NAN
weight_type: ivm
output_shape: None
pixel_scale_ratio: 1.0
pixel_scale: None
output_wcs: ''
single: False
blendheaders: True
in_memory: True
extract_1d:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
subtract_background: None
apply_apcorr: True
extraction_type: box
use_source_posn: None
position_offset: 0.0
model_nod_pair: True
optimize_psf_location: True
smoothing_length: None
bkg_fit: None
bkg_order: None
log_increment: 50
save_profile: False
save_scene_model: False
save_residual_image: False
center_xy: None
ifu_autocen: False
bkg_sigma_clip: 3.0
ifu_rfcorr: True
ifu_set_srctype: None
ifu_rscale: None
ifu_covar_scale: 1.0
soss_atoca: True
soss_threshold: 0.01
soss_n_os: 2
soss_wave_grid_in: None
soss_wave_grid_out: None
soss_estimate: None
soss_rtol: 0.0001
soss_max_grid_size: 20000
soss_tikfac: None
soss_width: 40.0
soss_bad_pix: masking
soss_modelname: None
wavecorr:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
flat_field:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
save_interpolated_flat: False
user_supplied_flat: None
inverse: False
srctype:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
source_type: None
straylight:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
clean_showers: False
shower_plane: 3
shower_x_stddev: 18.0
shower_y_stddev: 5.0
shower_low_reject: 0.1
shower_high_reject: 99.9
save_shower_model: False
fringe:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
residual_fringe:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: True
suffix: residual_fringe
search_output_file: False
input_dir: ''
save_intermediate_results: False
ignore_region_min: None
ignore_region_max: None
pathloss:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
inverse: False
source_type: None
user_slit_loc: None
barshadow:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
inverse: False
source_type: None
wfss_contam:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: True
suffix: None
search_output_file: True
input_dir: ''
save_simulated_image: False
save_contam_images: False
maximum_cores: none
photom:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
inverse: False
source_type: None
mrs_time_correction: True
pixel_replace:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: True
output_use_index: True
save_results: False
skip: True
suffix: None
search_output_file: True
input_dir: ''
algorithm: fit_profile
n_adjacent_cols: 3
resample_spec:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
pixfrac: 1.0
kernel: square
fillval: NAN
weight_type: ivm
output_shape: None
pixel_scale_ratio: 1.0
pixel_scale: None
output_wcs: ''
single: False
blendheaders: True
in_memory: True
cube_build:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: True
output_use_index: True
save_results: False
skip: False
suffix: s3d
search_output_file: False
input_dir: ''
channel: all
band: all
grating: all
filter: all
output_type: None
scalexy: 0.0
scalew: 0.0
weighting: drizzle
coord_system: skyalign
ra_center: None
dec_center: None
cube_pa: None
nspax_x: None
nspax_y: None
rois: 0.0
roiw: 0.0
weight_power: 2.0
wavemin: None
wavemax: None
single: False
skip_dqflagging: False
offset_file: None
debug_spaxel: -1 -1 -1
extract_1d:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
subtract_background: None
apply_apcorr: True
extraction_type: box
use_source_posn: None
position_offset: 0.0
model_nod_pair: True
optimize_psf_location: True
smoothing_length: None
bkg_fit: None
bkg_order: None
log_increment: 50
save_profile: False
save_scene_model: False
save_residual_image: False
center_xy: None
ifu_autocen: False
bkg_sigma_clip: 3.0
ifu_rfcorr: True
ifu_set_srctype: None
ifu_rscale: None
ifu_covar_scale: 1.0
soss_atoca: True
soss_threshold: 0.01
soss_n_os: 2
soss_wave_grid_in: None
soss_wave_grid_out: None
soss_estimate: None
soss_rtol: 0.0001
soss_max_grid_size: 20000
soss_tikfac: None
soss_width: 40.0
soss_bad_pix: masking
soss_modelname: None
2025-09-13 16:42:27,789 - stpipe.Spec2Pipeline - INFO - Prefetching reference files for dataset: 'jw02079004003_05101_00003_nis_spec2_asn.json' reftypes = ['apcorr', 'area', 'barshadow', 'bkg', 'camera', 'collimator', 'cubepar', 'dflat', 'disperser', 'distortion', 'extract1d', 'fflat', 'filteroffset', 'flat', 'fore', 'fpa', 'fringe', 'ifufore', 'ifupost', 'ifuslicer', 'mrsxartcorr', 'msa', 'msaoper', 'ote', 'pastasoss', 'pathloss', 'photom', 'psf', 'regions', 'sflat', 'speckernel', 'specprofile', 'specwcs', 'wavecorr', 'wavelengthrange']
2025-09-13 16:42:27,792 - stpipe.Spec2Pipeline - INFO - Prefetch for APCORR reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits'.
2025-09-13 16:42:27,793 - stpipe.Spec2Pipeline - INFO - Prefetch for AREA reference file is 'N/A'.
2025-09-13 16:42:27,793 - stpipe.Spec2Pipeline - INFO - Prefetch for BARSHADOW reference file is 'N/A'.
2025-09-13 16:42:27,794 - stpipe.Spec2Pipeline - INFO - Prefetch for BKG reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_bkg_0027.fits'.
2025-09-13 16:42:27,794 - stpipe.Spec2Pipeline - INFO - Prefetch for CAMERA reference file is 'N/A'.
2025-09-13 16:42:27,795 - stpipe.Spec2Pipeline - INFO - Prefetch for COLLIMATOR reference file is 'N/A'.
2025-09-13 16:42:27,795 - stpipe.Spec2Pipeline - INFO - Prefetch for CUBEPAR reference file is 'N/A'.
2025-09-13 16:42:27,795 - stpipe.Spec2Pipeline - INFO - Prefetch for DFLAT reference file is 'N/A'.
2025-09-13 16:42:27,795 - stpipe.Spec2Pipeline - INFO - Prefetch for DISPERSER reference file is 'N/A'.
2025-09-13 16:42:27,796 - stpipe.Spec2Pipeline - INFO - Prefetch for DISTORTION reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_distortion_0037.asdf'.
2025-09-13 16:42:27,796 - stpipe.Spec2Pipeline - INFO - Prefetch for EXTRACT1D reference file is 'N/A'.
2025-09-13 16:42:27,796 - stpipe.Spec2Pipeline - INFO - Prefetch for FFLAT reference file is 'N/A'.
2025-09-13 16:42:27,797 - stpipe.Spec2Pipeline - INFO - Prefetch for FILTEROFFSET reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_filteroffset_0006.asdf'.
2025-09-13 16:42:27,797 - stpipe.Spec2Pipeline - INFO - Prefetch for FLAT reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_flat_0265.fits'.
2025-09-13 16:42:27,798 - stpipe.Spec2Pipeline - INFO - Prefetch for FORE reference file is 'N/A'.
2025-09-13 16:42:27,798 - stpipe.Spec2Pipeline - INFO - Prefetch for FPA reference file is 'N/A'.
2025-09-13 16:42:27,798 - stpipe.Spec2Pipeline - INFO - Prefetch for FRINGE reference file is 'N/A'.
2025-09-13 16:42:27,799 - stpipe.Spec2Pipeline - INFO - Prefetch for IFUFORE reference file is 'N/A'.
2025-09-13 16:42:27,799 - stpipe.Spec2Pipeline - INFO - Prefetch for IFUPOST reference file is 'N/A'.
2025-09-13 16:42:27,799 - stpipe.Spec2Pipeline - INFO - Prefetch for IFUSLICER reference file is 'N/A'.
2025-09-13 16:42:27,799 - stpipe.Spec2Pipeline - INFO - Prefetch for MRSXARTCORR reference file is 'N/A'.
2025-09-13 16:42:27,800 - stpipe.Spec2Pipeline - INFO - Prefetch for MSA reference file is 'N/A'.
2025-09-13 16:42:27,800 - stpipe.Spec2Pipeline - INFO - Prefetch for MSAOPER reference file is 'N/A'.
2025-09-13 16:42:27,800 - stpipe.Spec2Pipeline - INFO - Prefetch for OTE reference file is 'N/A'.
2025-09-13 16:42:27,801 - stpipe.Spec2Pipeline - INFO - Prefetch for PASTASOSS reference file is 'N/A'.
2025-09-13 16:42:27,801 - stpipe.Spec2Pipeline - INFO - Prefetch for PATHLOSS reference file is 'N/A'.
2025-09-13 16:42:27,801 - stpipe.Spec2Pipeline - INFO - Prefetch for PHOTOM reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_photom_0041.fits'.
2025-09-13 16:42:27,802 - stpipe.Spec2Pipeline - INFO - Prefetch for PSF reference file is 'N/A'.
2025-09-13 16:42:27,802 - stpipe.Spec2Pipeline - INFO - Prefetch for REGIONS reference file is 'N/A'.
2025-09-13 16:42:27,802 - stpipe.Spec2Pipeline - INFO - Prefetch for SFLAT reference file is 'N/A'.
2025-09-13 16:42:27,803 - stpipe.Spec2Pipeline - INFO - Prefetch for SPECKERNEL reference file is 'N/A'.
2025-09-13 16:42:27,803 - stpipe.Spec2Pipeline - INFO - Prefetch for SPECPROFILE reference file is 'N/A'.
2025-09-13 16:42:27,804 - stpipe.Spec2Pipeline - INFO - Prefetch for SPECWCS reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_specwcs_0064.asdf'.
2025-09-13 16:42:27,805 - stpipe.Spec2Pipeline - INFO - Prefetch for WAVECORR reference file is 'N/A'.
2025-09-13 16:42:27,806 - stpipe.Spec2Pipeline - INFO - Prefetch for WAVELENGTHRANGE reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_wavelengthrange_0002.asdf'.
2025-09-13 16:42:27,806 - stpipe.Spec2Pipeline - INFO - Starting calwebb_spec2 ...
2025-09-13 16:42:27,812 - stpipe.Spec2Pipeline - INFO - Processing product /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage1/jw02079004003_05101_00003_nis
2025-09-13 16:42:27,813 - stpipe.Spec2Pipeline - INFO - Working on input /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage1/jw02079004003_05101_00003_nis_rate.fits ...
2025-09-13 16:42:27,862 - stpipe.Spec2Pipeline - INFO - Using sourcecat file jw02079-o004_niriss_clear-f200w_cat.ecsv
2025-09-13 16:42:27,863 - stpipe.Spec2Pipeline - INFO - Using segmentation map jw02079-o004_niriss_clear-f200w_segm.fits
2025-09-13 16:42:27,864 - stpipe.Spec2Pipeline - INFO - Using direct image jw02079-o004_niriss_clear-f200w_i2d.fits
2025-09-13 16:42:28,264 - stpipe.Spec2Pipeline.assign_wcs - INFO - Step assign_wcs running with args (<ImageModel(2048, 2048) from jw02079004003_05101_00003_nis_rate.fits>,).
2025-09-13 16:42:28,379 - jwst.assign_wcs.niriss - INFO - Added Barycentric velocity correction: 0.9999282770225614
2025-09-13 16:42:28,437 - jwst.assign_wcs.niriss - INFO - Offsets from filteroffset file are 2.119, -1.0476
2025-09-13 16:42:28,517 - jwst.assign_wcs.assign_wcs - INFO - COMPLETED assign_wcs
2025-09-13 16:42:28,519 - stpipe.AssignWcsStep - INFO - AssignWcsStep instance created.
2025-09-13 16:42:28,597 - jwst.assign_wcs.niriss - INFO - Offsets from filteroffset file are 2.119, -1.0476
2025-09-13 16:42:28,646 - stpipe.Spec2Pipeline.assign_wcs - INFO - Step assign_wcs done
2025-09-13 16:42:29,055 - stpipe.Spec2Pipeline.badpix_selfcal - INFO - Step badpix_selfcal running with args (<ImageModel(2048, 2048) from jw02079004003_05101_00003_nis_rate.fits>, [], []).
2025-09-13 16:42:29,056 - stpipe.Spec2Pipeline.badpix_selfcal - INFO - Step skipped.
2025-09-13 16:42:29,458 - stpipe.Spec2Pipeline.msa_flagging - INFO - Step msa_flagging running with args (<ImageModel(2048, 2048) from jw02079004003_05101_00003_nis_rate.fits>,).
2025-09-13 16:42:29,459 - stpipe.Spec2Pipeline.msa_flagging - INFO - Step skipped.
2025-09-13 16:42:29,869 - stpipe.Spec2Pipeline.nsclean - INFO - Step nsclean running with args (<ImageModel(2048, 2048) from jw02079004003_05101_00003_nis_rate.fits>,).
2025-09-13 16:42:29,869 - stpipe.Spec2Pipeline.nsclean - INFO - Step skipped.
2025-09-13 16:42:30,282 - stpipe.Spec2Pipeline.imprint_subtract - INFO - Step imprint_subtract running with args (<ImageModel(2048, 2048) from jw02079004003_05101_00003_nis_rate.fits>, []).
2025-09-13 16:42:30,283 - stpipe.Spec2Pipeline.imprint_subtract - INFO - Step skipped.
2025-09-13 16:42:30,696 - stpipe.Spec2Pipeline.bkg_subtract - INFO - Step bkg_subtract running with args (<ImageModel(2048, 2048) from jw02079004003_05101_00003_nis_rate.fits>, []).
2025-09-13 16:42:30,961 - jwst.background.asn_intake - INFO - Working on input <ImageModel(2048, 2048) from jw02079004003_05101_00003_nis_rate.fits> ...
2025-09-13 16:42:31,267 - stpipe.Spec2Pipeline.bkg_subtract - INFO - Using BKG reference file /home/runner/crds/references/jwst/niriss/jwst_niriss_bkg_0027.fits
2025-09-13 16:42:31,268 - stpipe.Spec2Pipeline.bkg_subtract - INFO - Using WavelengthRange reference file /home/runner/crds/references/jwst/niriss/jwst_niriss_wavelengthrange_0002.asdf
2025-09-13 16:42:31,332 - jwst.assign_wcs.util - INFO - Getting objects from jw02079-o004_niriss_clear-f200w_cat.ecsv
2025-09-13 16:42:31,642 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1, order 1
2025-09-13 16:42:31,655 - jwst.assign_wcs.util - INFO - Excluding off-image object: 2, order 1
2025-09-13 16:42:31,667 - jwst.assign_wcs.util - INFO - Excluding off-image object: 3, order 1
2025-09-13 16:42:31,679 - jwst.assign_wcs.util - INFO - Excluding off-image object: 4, order 1
2025-09-13 16:42:31,691 - jwst.assign_wcs.util - INFO - Excluding off-image object: 5, order 1
2025-09-13 16:42:31,703 - jwst.assign_wcs.util - INFO - Excluding off-image object: 6, order 1
2025-09-13 16:42:31,715 - jwst.assign_wcs.util - INFO - Excluding off-image object: 7, order 1
2025-09-13 16:42:31,727 - jwst.assign_wcs.util - INFO - Excluding off-image object: 8, order 1
2025-09-13 16:42:31,739 - jwst.assign_wcs.util - INFO - Excluding off-image object: 9, order 1
2025-09-13 16:42:31,751 - jwst.assign_wcs.util - INFO - Excluding off-image object: 10, order 1
2025-09-13 16:42:31,763 - jwst.assign_wcs.util - INFO - Excluding off-image object: 11, order 1
2025-09-13 16:42:31,775 - jwst.assign_wcs.util - INFO - Excluding off-image object: 12, order 1
2025-09-13 16:42:31,787 - jwst.assign_wcs.util - INFO - Excluding off-image object: 13, order 1
2025-09-13 16:42:31,799 - jwst.assign_wcs.util - INFO - Excluding off-image object: 14, order 1
2025-09-13 16:42:31,811 - jwst.assign_wcs.util - INFO - Excluding off-image object: 15, order 1
2025-09-13 16:42:31,824 - jwst.assign_wcs.util - INFO - Excluding off-image object: 16, order 1
2025-09-13 16:42:31,835 - jwst.assign_wcs.util - INFO - Excluding off-image object: 17, order 1
2025-09-13 16:42:31,848 - jwst.assign_wcs.util - INFO - Excluding off-image object: 18, order 1
2025-09-13 16:42:31,860 - jwst.assign_wcs.util - INFO - Excluding off-image object: 19, order 1
2025-09-13 16:42:31,872 - jwst.assign_wcs.util - INFO - Excluding off-image object: 20, order 1
2025-09-13 16:42:31,884 - jwst.assign_wcs.util - INFO - Excluding off-image object: 21, order 1
2025-09-13 16:42:31,896 - jwst.assign_wcs.util - INFO - Excluding off-image object: 22, order 1
2025-09-13 16:42:31,908 - jwst.assign_wcs.util - INFO - Excluding off-image object: 23, order 1
2025-09-13 16:42:31,920 - jwst.assign_wcs.util - INFO - Excluding off-image object: 24, order 1
2025-09-13 16:42:31,932 - jwst.assign_wcs.util - INFO - Excluding off-image object: 25, order 1
2025-09-13 16:42:31,944 - jwst.assign_wcs.util - INFO - Excluding off-image object: 26, order 1
2025-09-13 16:42:31,956 - jwst.assign_wcs.util - INFO - Excluding off-image object: 27, order 1
2025-09-13 16:42:31,968 - jwst.assign_wcs.util - INFO - Excluding off-image object: 28, order 1
2025-09-13 16:42:31,980 - jwst.assign_wcs.util - INFO - Excluding off-image object: 29, order 1
2025-09-13 16:42:31,992 - jwst.assign_wcs.util - INFO - Excluding off-image object: 30, order 1
2025-09-13 16:42:32,004 - jwst.assign_wcs.util - INFO - Excluding off-image object: 31, order 1
2025-09-13 16:42:32,016 - jwst.assign_wcs.util - INFO - Excluding off-image object: 32, order 1
2025-09-13 16:42:32,028 - jwst.assign_wcs.util - INFO - Excluding off-image object: 33, order 1
2025-09-13 16:42:32,040 - jwst.assign_wcs.util - INFO - Excluding off-image object: 34, order 1
2025-09-13 16:42:32,053 - jwst.assign_wcs.util - INFO - Excluding off-image object: 35, order 1
2025-09-13 16:42:32,065 - jwst.assign_wcs.util - INFO - Excluding off-image object: 36, order 1
2025-09-13 16:42:32,077 - jwst.assign_wcs.util - INFO - Excluding off-image object: 37, order 1
2025-09-13 16:42:32,089 - jwst.assign_wcs.util - INFO - Excluding off-image object: 38, order 1
2025-09-13 16:42:32,101 - jwst.assign_wcs.util - INFO - Excluding off-image object: 39, order 1
2025-09-13 16:42:32,113 - jwst.assign_wcs.util - INFO - Excluding off-image object: 40, order 1
2025-09-13 16:42:32,125 - jwst.assign_wcs.util - INFO - Excluding off-image object: 41, order 1
2025-09-13 16:42:32,137 - jwst.assign_wcs.util - INFO - Excluding off-image object: 42, order 1
2025-09-13 16:42:32,149 - jwst.assign_wcs.util - INFO - Excluding off-image object: 43, order 1
2025-09-13 16:42:32,160 - jwst.assign_wcs.util - INFO - Excluding off-image object: 44, order 1
2025-09-13 16:42:32,172 - jwst.assign_wcs.util - INFO - Excluding off-image object: 45, order 1
2025-09-13 16:42:32,185 - jwst.assign_wcs.util - INFO - Excluding off-image object: 46, order 1
2025-09-13 16:42:32,197 - jwst.assign_wcs.util - INFO - Excluding off-image object: 47, order 1
2025-09-13 16:42:32,209 - jwst.assign_wcs.util - INFO - Excluding off-image object: 48, order 1
2025-09-13 16:42:32,221 - jwst.assign_wcs.util - INFO - Excluding off-image object: 49, order 1
2025-09-13 16:42:32,233 - jwst.assign_wcs.util - INFO - Excluding off-image object: 50, order 1
2025-09-13 16:42:32,245 - jwst.assign_wcs.util - INFO - Excluding off-image object: 51, order 1
2025-09-13 16:42:32,257 - jwst.assign_wcs.util - INFO - Excluding off-image object: 52, order 1
2025-09-13 16:42:32,269 - jwst.assign_wcs.util - INFO - Excluding off-image object: 53, order 1
2025-09-13 16:42:32,281 - jwst.assign_wcs.util - INFO - Excluding off-image object: 54, order 1
2025-09-13 16:42:32,296 - jwst.assign_wcs.util - INFO - Excluding off-image object: 55, order 1
2025-09-13 16:42:32,308 - jwst.assign_wcs.util - INFO - Excluding off-image object: 56, order 1
2025-09-13 16:42:32,320 - jwst.assign_wcs.util - INFO - Excluding off-image object: 57, order 1
2025-09-13 16:42:32,332 - jwst.assign_wcs.util - INFO - Excluding off-image object: 58, order 1
2025-09-13 16:42:32,344 - jwst.assign_wcs.util - INFO - Excluding off-image object: 59, order 1
2025-09-13 16:42:32,357 - jwst.assign_wcs.util - INFO - Excluding off-image object: 60, order 1
2025-09-13 16:42:32,369 - jwst.assign_wcs.util - INFO - Excluding off-image object: 61, order 1
2025-09-13 16:42:32,381 - jwst.assign_wcs.util - INFO - Excluding off-image object: 62, order 1
2025-09-13 16:42:32,393 - jwst.assign_wcs.util - INFO - Excluding off-image object: 63, order 1
2025-09-13 16:42:32,405 - jwst.assign_wcs.util - INFO - Excluding off-image object: 64, order 1
2025-09-13 16:42:32,417 - jwst.assign_wcs.util - INFO - Excluding off-image object: 65, order 1
2025-09-13 16:42:32,430 - jwst.assign_wcs.util - INFO - Excluding off-image object: 66, order 1
2025-09-13 16:42:32,442 - jwst.assign_wcs.util - INFO - Excluding off-image object: 67, order 1
2025-09-13 16:42:32,455 - jwst.assign_wcs.util - INFO - Excluding off-image object: 68, order 1
2025-09-13 16:42:32,468 - jwst.assign_wcs.util - INFO - Excluding off-image object: 69, order 1
2025-09-13 16:42:32,481 - jwst.assign_wcs.util - INFO - Excluding off-image object: 70, order 1
2025-09-13 16:42:32,494 - jwst.assign_wcs.util - INFO - Excluding off-image object: 71, order 1
2025-09-13 16:42:32,506 - jwst.assign_wcs.util - INFO - Excluding off-image object: 72, order 1
2025-09-13 16:42:32,518 - jwst.assign_wcs.util - INFO - Excluding off-image object: 73, order 1
2025-09-13 16:42:32,530 - jwst.assign_wcs.util - INFO - Excluding off-image object: 74, order 1
2025-09-13 16:42:32,543 - jwst.assign_wcs.util - INFO - Excluding off-image object: 75, order 1
2025-09-13 16:42:32,555 - jwst.assign_wcs.util - INFO - Excluding off-image object: 76, order 1
2025-09-13 16:42:32,567 - jwst.assign_wcs.util - INFO - Excluding off-image object: 77, order 1
2025-09-13 16:42:32,579 - jwst.assign_wcs.util - INFO - Excluding off-image object: 78, order 1
2025-09-13 16:42:32,591 - jwst.assign_wcs.util - INFO - Excluding off-image object: 79, order 1
2025-09-13 16:42:32,603 - jwst.assign_wcs.util - INFO - Excluding off-image object: 80, order 1
2025-09-13 16:42:32,615 - jwst.assign_wcs.util - INFO - Excluding off-image object: 81, order 1
2025-09-13 16:42:32,628 - jwst.assign_wcs.util - INFO - Excluding off-image object: 82, order 1
2025-09-13 16:42:32,640 - jwst.assign_wcs.util - INFO - Excluding off-image object: 83, order 1
2025-09-13 16:42:32,652 - jwst.assign_wcs.util - INFO - Excluding off-image object: 84, order 1
2025-09-13 16:42:32,664 - jwst.assign_wcs.util - INFO - Excluding off-image object: 85, order 1
2025-09-13 16:42:32,676 - jwst.assign_wcs.util - INFO - Excluding off-image object: 86, order 1
2025-09-13 16:42:32,688 - jwst.assign_wcs.util - INFO - Excluding off-image object: 87, order 1
2025-09-13 16:42:32,700 - jwst.assign_wcs.util - INFO - Excluding off-image object: 88, order 1
2025-09-13 16:42:32,712 - jwst.assign_wcs.util - INFO - Excluding off-image object: 89, order 1
2025-09-13 16:42:32,725 - jwst.assign_wcs.util - INFO - Excluding off-image object: 90, order 1
2025-09-13 16:42:32,737 - jwst.assign_wcs.util - INFO - Excluding off-image object: 91, order 1
2025-09-13 16:42:32,749 - jwst.assign_wcs.util - INFO - Excluding off-image object: 92, order 1
2025-09-13 16:42:32,761 - jwst.assign_wcs.util - INFO - Excluding off-image object: 93, order 1
2025-09-13 16:42:32,773 - jwst.assign_wcs.util - INFO - Excluding off-image object: 94, order 1
2025-09-13 16:42:32,785 - jwst.assign_wcs.util - INFO - Excluding off-image object: 95, order 1
2025-09-13 16:42:32,798 - jwst.assign_wcs.util - INFO - Excluding off-image object: 96, order 1
2025-09-13 16:42:32,810 - jwst.assign_wcs.util - INFO - Excluding off-image object: 97, order 1
2025-09-13 16:42:32,823 - jwst.assign_wcs.util - INFO - Excluding off-image object: 98, order 1
2025-09-13 16:42:32,835 - jwst.assign_wcs.util - INFO - Excluding off-image object: 99, order 1
2025-09-13 16:42:32,848 - jwst.assign_wcs.util - INFO - Excluding off-image object: 100, order 1
2025-09-13 16:42:32,860 - jwst.assign_wcs.util - INFO - Excluding off-image object: 101, order 1
2025-09-13 16:42:32,872 - jwst.assign_wcs.util - INFO - Excluding off-image object: 102, order 1
2025-09-13 16:42:32,885 - jwst.assign_wcs.util - INFO - Excluding off-image object: 103, order 1
2025-09-13 16:42:32,897 - jwst.assign_wcs.util - INFO - Excluding off-image object: 104, order 1
2025-09-13 16:42:32,910 - jwst.assign_wcs.util - INFO - Excluding off-image object: 105, order 1
2025-09-13 16:42:32,922 - jwst.assign_wcs.util - INFO - Excluding off-image object: 106, order 1
2025-09-13 16:42:32,934 - jwst.assign_wcs.util - INFO - Excluding off-image object: 107, order 1
2025-09-13 16:42:32,947 - jwst.assign_wcs.util - INFO - Excluding off-image object: 108, order 1
2025-09-13 16:42:32,959 - jwst.assign_wcs.util - INFO - Excluding off-image object: 109, order 1
2025-09-13 16:42:32,971 - jwst.assign_wcs.util - INFO - Excluding off-image object: 110, order 1
2025-09-13 16:42:32,983 - jwst.assign_wcs.util - INFO - Excluding off-image object: 111, order 1
2025-09-13 16:42:32,996 - jwst.assign_wcs.util - INFO - Excluding off-image object: 112, order 1
2025-09-13 16:42:33,008 - jwst.assign_wcs.util - INFO - Excluding off-image object: 113, order 1
2025-09-13 16:42:33,020 - jwst.assign_wcs.util - INFO - Excluding off-image object: 114, order 1
2025-09-13 16:42:33,033 - jwst.assign_wcs.util - INFO - Excluding off-image object: 115, order 1
2025-09-13 16:42:33,045 - jwst.assign_wcs.util - INFO - Excluding off-image object: 116, order 1
2025-09-13 16:42:33,058 - jwst.assign_wcs.util - INFO - Excluding off-image object: 117, order 1
2025-09-13 16:42:33,078 - jwst.assign_wcs.util - INFO - Excluding off-image object: 118, order 1
2025-09-13 16:42:33,090 - jwst.assign_wcs.util - INFO - Excluding off-image object: 119, order 1
2025-09-13 16:42:33,102 - jwst.assign_wcs.util - INFO - Excluding off-image object: 120, order 1
2025-09-13 16:42:33,114 - jwst.assign_wcs.util - INFO - Excluding off-image object: 121, order 1
2025-09-13 16:42:33,127 - jwst.assign_wcs.util - INFO - Excluding off-image object: 122, order 1
2025-09-13 16:42:33,139 - jwst.assign_wcs.util - INFO - Excluding off-image object: 123, order 1
2025-09-13 16:42:33,152 - jwst.assign_wcs.util - INFO - Excluding off-image object: 124, order 1
2025-09-13 16:42:33,164 - jwst.assign_wcs.util - INFO - Excluding off-image object: 125, order 1
2025-09-13 16:42:33,177 - jwst.assign_wcs.util - INFO - Excluding off-image object: 126, order 1
2025-09-13 16:42:33,189 - jwst.assign_wcs.util - INFO - Excluding off-image object: 127, order 1
2025-09-13 16:42:33,202 - jwst.assign_wcs.util - INFO - Excluding off-image object: 128, order 1
2025-09-13 16:42:33,214 - jwst.assign_wcs.util - INFO - Excluding off-image object: 129, order 1
2025-09-13 16:42:33,227 - jwst.assign_wcs.util - INFO - Excluding off-image object: 130, order 1
2025-09-13 16:42:33,239 - jwst.assign_wcs.util - INFO - Excluding off-image object: 131, order 1
2025-09-13 16:42:33,252 - jwst.assign_wcs.util - INFO - Excluding off-image object: 132, order 1
2025-09-13 16:42:33,264 - jwst.assign_wcs.util - INFO - Excluding off-image object: 133, order 1
2025-09-13 16:42:33,276 - jwst.assign_wcs.util - INFO - Excluding off-image object: 134, order 1
2025-09-13 16:42:33,288 - jwst.assign_wcs.util - INFO - Excluding off-image object: 135, order 1
2025-09-13 16:42:33,302 - jwst.assign_wcs.util - INFO - Excluding off-image object: 136, order 1
2025-09-13 16:42:33,315 - jwst.assign_wcs.util - INFO - Excluding off-image object: 137, order 1
2025-09-13 16:42:33,327 - jwst.assign_wcs.util - INFO - Excluding off-image object: 138, order 1
2025-09-13 16:42:33,339 - jwst.assign_wcs.util - INFO - Excluding off-image object: 139, order 1
2025-09-13 16:42:33,351 - jwst.assign_wcs.util - INFO - Excluding off-image object: 140, order 1
2025-09-13 16:42:33,364 - jwst.assign_wcs.util - INFO - Excluding off-image object: 141, order 1
2025-09-13 16:42:33,376 - jwst.assign_wcs.util - INFO - Excluding off-image object: 142, order 1
2025-09-13 16:42:33,388 - jwst.assign_wcs.util - INFO - Excluding off-image object: 143, order 1
2025-09-13 16:42:33,401 - jwst.assign_wcs.util - INFO - Excluding off-image object: 144, order 1
2025-09-13 16:42:33,413 - jwst.assign_wcs.util - INFO - Excluding off-image object: 145, order 1
2025-09-13 16:42:33,425 - jwst.assign_wcs.util - INFO - Excluding off-image object: 146, order 1
2025-09-13 16:42:33,438 - jwst.assign_wcs.util - INFO - Excluding off-image object: 147, order 1
2025-09-13 16:42:33,450 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 148 order: 1
2025-09-13 16:42:33,462 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 149 order: 1
2025-09-13 16:42:33,474 - jwst.assign_wcs.util - INFO - Excluding off-image object: 150, order 1
2025-09-13 16:42:33,486 - jwst.assign_wcs.util - INFO - Excluding off-image object: 151, order 1
2025-09-13 16:42:33,499 - jwst.assign_wcs.util - INFO - Excluding off-image object: 152, order 1
2025-09-13 16:42:33,511 - jwst.assign_wcs.util - INFO - Excluding off-image object: 153, order 1
2025-09-13 16:42:33,523 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 154 order: 1
2025-09-13 16:42:33,535 - jwst.assign_wcs.util - INFO - Excluding off-image object: 155, order 1
2025-09-13 16:42:33,547 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 156 order: 1
2025-09-13 16:42:33,791 - jwst.assign_wcs.util - INFO - Excluding off-image object: 177, order 1
2025-09-13 16:42:33,816 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 179 order: 1
2025-09-13 16:42:33,840 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 181 order: 1
2025-09-13 16:42:33,899 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 186 order: 1
2025-09-13 16:42:33,946 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 190 order: 1
2025-09-13 16:42:34,040 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 198 order: 1
2025-09-13 16:42:34,064 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 200 order: 1
2025-09-13 16:42:34,101 - jwst.assign_wcs.util - INFO - Excluding off-image object: 203, order 1
2025-09-13 16:42:34,138 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 206 order: 1
2025-09-13 16:42:34,151 - jwst.assign_wcs.util - INFO - Excluding off-image object: 207, order 1
2025-09-13 16:42:34,292 - jwst.assign_wcs.util - INFO - Excluding off-image object: 219, order 1
2025-09-13 16:42:34,351 - jwst.assign_wcs.util - INFO - Excluding off-image object: 224, order 1
2025-09-13 16:42:34,410 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 229 order: 1
2025-09-13 16:42:34,434 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 231 order: 1
2025-09-13 16:42:34,620 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 247 order: 1
2025-09-13 16:42:34,632 - jwst.assign_wcs.util - INFO - Excluding off-image object: 248, order 1
2025-09-13 16:42:34,645 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 249 order: 1
2025-09-13 16:42:34,981 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 278 order: 1
2025-09-13 16:42:35,040 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 283 order: 1
2025-09-13 16:42:35,193 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 296 order: 1
2025-09-13 16:42:35,286 - jwst.assign_wcs.util - INFO - Excluding off-image object: 304, order 1
2025-09-13 16:42:35,298 - jwst.assign_wcs.util - INFO - Excluding off-image object: 305, order 1
2025-09-13 16:42:35,310 - jwst.assign_wcs.util - INFO - Excluding off-image object: 306, order 1
2025-09-13 16:42:35,521 - jwst.assign_wcs.util - INFO - Excluding off-image object: 324, order 1
2025-09-13 16:42:35,580 - jwst.assign_wcs.util - INFO - Excluding off-image object: 329, order 1
2025-09-13 16:42:35,593 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 330 order: 1
2025-09-13 16:42:35,922 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 357 order: 1
2025-09-13 16:42:35,935 - jwst.assign_wcs.util - INFO - Excluding off-image object: 358, order 1
2025-09-13 16:42:35,971 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 361 order: 1
2025-09-13 16:42:36,019 - jwst.assign_wcs.util - INFO - Excluding off-image object: 365, order 1
2025-09-13 16:42:36,078 - jwst.assign_wcs.util - INFO - Excluding off-image object: 370, order 1
2025-09-13 16:42:36,091 - jwst.assign_wcs.util - INFO - Excluding off-image object: 371, order 1
2025-09-13 16:42:36,153 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 376 order: 1
2025-09-13 16:42:36,297 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 388 order: 1
2025-09-13 16:42:36,716 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 423 order: 1
2025-09-13 16:42:36,984 - jwst.assign_wcs.util - INFO - Excluding off-image object: 445, order 1
2025-09-13 16:42:37,033 - jwst.assign_wcs.util - INFO - Excluding off-image object: 449, order 1
2025-09-13 16:42:37,276 - jwst.assign_wcs.util - INFO - Excluding off-image object: 469, order 1
2025-09-13 16:42:37,472 - jwst.assign_wcs.util - INFO - Excluding off-image object: 485, order 1
2025-09-13 16:42:37,497 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 487 order: 1
2025-09-13 16:42:37,642 - jwst.assign_wcs.util - INFO - Excluding off-image object: 499, order 1
2025-09-13 16:42:38,470 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 569 order: 1
2025-09-13 16:42:38,625 - jwst.assign_wcs.util - INFO - Excluding off-image object: 582, order 1
2025-09-13 16:42:38,853 - jwst.assign_wcs.util - INFO - Excluding off-image object: 601, order 1
2025-09-13 16:42:38,947 - jwst.assign_wcs.util - INFO - Excluding off-image object: 609, order 1
2025-09-13 16:42:38,959 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 610 order: 1
2025-09-13 16:42:39,183 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 629 order: 1
2025-09-13 16:42:39,394 - jwst.assign_wcs.util - INFO - Excluding off-image object: 647, order 1
2025-09-13 16:42:39,551 - jwst.assign_wcs.util - INFO - Excluding off-image object: 660, order 1
2025-09-13 16:42:39,599 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 664 order: 1
2025-09-13 16:42:39,612 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 665 order: 1
2025-09-13 16:42:39,672 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 670 order: 1
2025-09-13 16:42:39,709 - jwst.assign_wcs.util - INFO - Excluding off-image object: 673, order 1
2025-09-13 16:42:39,893 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 688 order: 1
2025-09-13 16:42:39,955 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 693 order: 1
2025-09-13 16:42:39,992 - jwst.assign_wcs.util - INFO - Excluding off-image object: 696, order 1
2025-09-13 16:42:40,029 - jwst.assign_wcs.util - INFO - Excluding off-image object: 699, order 1
2025-09-13 16:42:40,232 - jwst.assign_wcs.util - INFO - Excluding off-image object: 716, order 1
2025-09-13 16:42:40,327 - jwst.assign_wcs.util - INFO - Excluding off-image object: 724, order 1
2025-09-13 16:42:40,398 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 730 order: 1
2025-09-13 16:42:40,469 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 736 order: 1
2025-09-13 16:42:40,493 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 738 order: 1
2025-09-13 16:42:40,540 - jwst.assign_wcs.util - INFO - Excluding off-image object: 742, order 1
2025-09-13 16:42:40,552 - jwst.assign_wcs.util - INFO - Excluding off-image object: 743, order 1
2025-09-13 16:42:40,717 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 757 order: 1
2025-09-13 16:42:40,752 - jwst.assign_wcs.util - INFO - Excluding off-image object: 760, order 1
2025-09-13 16:42:40,881 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 771 order: 1
2025-09-13 16:42:40,987 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 780 order: 1
2025-09-13 16:42:41,256 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 803 order: 1
2025-09-13 16:42:41,467 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 821 order: 1
2025-09-13 16:42:41,573 - jwst.assign_wcs.util - INFO - Excluding off-image object: 830, order 1
2025-09-13 16:42:41,610 - jwst.assign_wcs.util - INFO - Excluding off-image object: 833, order 1
2025-09-13 16:42:41,744 - jwst.assign_wcs.util - INFO - Excluding off-image object: 844, order 1
2025-09-13 16:42:41,850 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 853 order: 1
2025-09-13 16:42:41,862 - jwst.assign_wcs.util - INFO - Excluding off-image object: 854, order 1
2025-09-13 16:42:42,140 - jwst.assign_wcs.util - INFO - Excluding off-image object: 878, order 1
2025-09-13 16:42:42,326 - jwst.assign_wcs.util - INFO - Excluding off-image object: 894, order 1
2025-09-13 16:42:42,420 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 902 order: 1
2025-09-13 16:42:42,513 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 910 order: 1
2025-09-13 16:42:42,597 - jwst.assign_wcs.util - INFO - Excluding off-image object: 917, order 1
2025-09-13 16:42:42,633 - jwst.assign_wcs.util - INFO - Excluding off-image object: 920, order 1
2025-09-13 16:42:42,703 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 926 order: 1
2025-09-13 16:42:42,971 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 949 order: 1
2025-09-13 16:42:43,030 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 954 order: 1
2025-09-13 16:42:43,321 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 979 order: 1
2025-09-13 16:42:43,404 - jwst.assign_wcs.util - INFO - Excluding off-image object: 986, order 1
2025-09-13 16:42:43,498 - jwst.assign_wcs.util - INFO - Excluding off-image object: 994, order 1
2025-09-13 16:42:43,580 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1001, order 1
2025-09-13 16:42:43,592 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1002 order: 1
2025-09-13 16:42:43,685 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1010 order: 1
2025-09-13 16:42:43,698 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1011 order: 1
2025-09-13 16:42:43,710 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1012 order: 1
2025-09-13 16:42:43,746 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1015, order 1
2025-09-13 16:42:43,781 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1018, order 1
2025-09-13 16:42:43,804 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1020, order 1
2025-09-13 16:42:43,908 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1029 order: 1
2025-09-13 16:42:43,968 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1034, order 1
2025-09-13 16:42:44,145 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1049 order: 1
2025-09-13 16:42:44,169 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1051 order: 1
2025-09-13 16:42:44,194 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1053 order: 1
2025-09-13 16:42:44,618 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1089 order: 1
2025-09-13 16:42:44,666 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1093, order 1
2025-09-13 16:42:44,714 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1097, order 1
2025-09-13 16:42:44,785 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1103, order 1
2025-09-13 16:42:44,866 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1110, order 1
2025-09-13 16:42:45,042 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1125 order: 1
2025-09-13 16:42:45,240 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1142 order: 1
2025-09-13 16:42:45,298 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1147 order: 1
2025-09-13 16:42:45,381 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1154, order 1
2025-09-13 16:42:45,418 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1157, order 1
2025-09-13 16:42:45,454 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1160 order: 1
2025-09-13 16:42:45,559 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1169, order 1
2025-09-13 16:42:45,607 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1173, order 1
2025-09-13 16:42:45,678 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1179, order 1
2025-09-13 16:42:45,876 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1196 order: 1
2025-09-13 16:42:45,948 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1202, order 1
2025-09-13 16:42:45,960 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1203 order: 1
2025-09-13 16:42:45,985 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1205, order 1
2025-09-13 16:42:46,057 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1211, order 1
2025-09-13 16:42:46,165 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1220 order: 1
2025-09-13 16:42:46,202 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1223, order 1
2025-09-13 16:42:46,263 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1228, order 1
2025-09-13 16:42:46,311 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1232 order: 1
2025-09-13 16:42:46,324 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1233, order 1
2025-09-13 16:42:46,431 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1242 order: 1
2025-09-13 16:42:46,703 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1265 order: 1
2025-09-13 16:42:46,943 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1286, order 1
2025-09-13 16:42:47,001 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1291 order: 1
2025-09-13 16:42:47,037 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1294 order: 1
2025-09-13 16:42:47,073 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1297 order: 1
2025-09-13 16:42:47,180 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1306 order: 1
2025-09-13 16:42:47,348 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1320, order 1
2025-09-13 16:42:47,384 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1323, order 1
2025-09-13 16:42:47,827 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1361 order: 1
2025-09-13 16:42:47,979 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1374 order: 1
2025-09-13 16:42:48,038 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1379, order 1
2025-09-13 16:42:48,109 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1385 order: 1
2025-09-13 16:42:48,192 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1392 order: 1
2025-09-13 16:42:48,309 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1402 order: 1
2025-09-13 16:42:48,570 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1424 order: 1
2025-09-13 16:42:48,582 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1425, order 1
2025-09-13 16:42:48,771 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1441, order 1
2025-09-13 16:42:48,819 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1445 order: 1
2025-09-13 16:42:48,867 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1449 order: 1
2025-09-13 16:42:48,995 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1460 order: 1
2025-09-13 16:42:49,182 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1476 order: 1
2025-09-13 16:42:49,229 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1480 order: 1
2025-09-13 16:42:49,313 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1487, order 1
2025-09-13 16:42:49,360 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1491 order: 1
2025-09-13 16:42:49,419 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1496 order: 1
2025-09-13 16:42:49,455 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1499 order: 1
2025-09-13 16:42:49,491 - jwst.assign_wcs.util - INFO - Total of 1280 grism objects defined
2025-09-13 16:42:49,530 - jwst.background.background_sub_wfss - INFO - Starting iterative outlier rejection for background subtraction.
2025-09-13 16:42:50,080 - jwst.background.background_sub_wfss - INFO - Stopped at maxiter (5).
2025-09-13 16:42:50,262 - jwst.background.background_sub_wfss - INFO - Average of scaled background image = 4.452e-01
2025-09-13 16:42:50,263 - jwst.background.background_sub_wfss - INFO - Scaling factor = 4.59749e-01
2025-09-13 16:42:50,269 - stpipe.Spec2Pipeline.bkg_subtract - INFO - Step bkg_subtract done
2025-09-13 16:42:50,707 - stpipe.Spec2Pipeline.flat_field - INFO - Step flat_field running with args (<ImageModel(2048, 2048) from jw02079004003_05101_00003_nis_rate.fits>,).
2025-09-13 16:42:50,782 - stpipe.Spec2Pipeline.flat_field - INFO - Using FLAT reference file: /home/runner/crds/references/jwst/niriss/jwst_niriss_flat_0265.fits
2025-09-13 16:42:50,783 - stpipe.Spec2Pipeline.flat_field - INFO - No reference found for type FFLAT
2025-09-13 16:42:50,783 - stpipe.Spec2Pipeline.flat_field - INFO - No reference found for type SFLAT
2025-09-13 16:42:50,784 - stpipe.Spec2Pipeline.flat_field - INFO - No reference found for type DFLAT
2025-09-13 16:42:51,003 - stpipe.Spec2Pipeline.flat_field - INFO - Step flat_field done
2025-09-13 16:42:51,443 - stpipe.Spec2Pipeline.extract_2d - INFO - Step extract_2d running with args (<ImageModel(2048, 2048) from jw02079004003_05101_00003_nis_rate.fits>,).
2025-09-13 16:42:51,454 - jwst.extract_2d.extract_2d - INFO - EXP_TYPE is NIS_WFSS
2025-09-13 16:42:51,465 - jwst.assign_wcs.util - INFO - Getting objects from jw02079-o004_niriss_clear-f200w_cat.ecsv
2025-09-13 16:42:51,773 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1, order 1
2025-09-13 16:42:51,786 - jwst.assign_wcs.util - INFO - Excluding off-image object: 2, order 1
2025-09-13 16:42:51,795 - jwst.assign_wcs.util - INFO - Excluding off-image object: 3, order 1
2025-09-13 16:42:51,807 - jwst.assign_wcs.util - INFO - Excluding off-image object: 4, order 1
2025-09-13 16:42:51,819 - jwst.assign_wcs.util - INFO - Excluding off-image object: 5, order 1
2025-09-13 16:42:51,831 - jwst.assign_wcs.util - INFO - Excluding off-image object: 6, order 1
2025-09-13 16:42:51,843 - jwst.assign_wcs.util - INFO - Excluding off-image object: 7, order 1
2025-09-13 16:42:51,856 - jwst.assign_wcs.util - INFO - Excluding off-image object: 8, order 1
2025-09-13 16:42:51,868 - jwst.assign_wcs.util - INFO - Excluding off-image object: 9, order 1
2025-09-13 16:42:51,881 - jwst.assign_wcs.util - INFO - Excluding off-image object: 10, order 1
2025-09-13 16:42:51,893 - jwst.assign_wcs.util - INFO - Excluding off-image object: 11, order 1
2025-09-13 16:42:51,905 - jwst.assign_wcs.util - INFO - Excluding off-image object: 12, order 1
2025-09-13 16:42:51,917 - jwst.assign_wcs.util - INFO - Excluding off-image object: 13, order 1
2025-09-13 16:42:51,928 - jwst.assign_wcs.util - INFO - Excluding off-image object: 14, order 1
2025-09-13 16:42:51,940 - jwst.assign_wcs.util - INFO - Excluding off-image object: 15, order 1
2025-09-13 16:42:51,952 - jwst.assign_wcs.util - INFO - Excluding off-image object: 16, order 1
2025-09-13 16:42:51,963 - jwst.assign_wcs.util - INFO - Excluding off-image object: 17, order 1
2025-09-13 16:42:51,975 - jwst.assign_wcs.util - INFO - Excluding off-image object: 18, order 1
2025-09-13 16:42:51,987 - jwst.assign_wcs.util - INFO - Excluding off-image object: 19, order 1
2025-09-13 16:42:51,999 - jwst.assign_wcs.util - INFO - Excluding off-image object: 20, order 1
2025-09-13 16:42:52,011 - jwst.assign_wcs.util - INFO - Excluding off-image object: 21, order 1
2025-09-13 16:42:52,022 - jwst.assign_wcs.util - INFO - Excluding off-image object: 22, order 1
2025-09-13 16:42:52,034 - jwst.assign_wcs.util - INFO - Excluding off-image object: 23, order 1
2025-09-13 16:42:52,046 - jwst.assign_wcs.util - INFO - Excluding off-image object: 24, order 1
2025-09-13 16:42:52,058 - jwst.assign_wcs.util - INFO - Excluding off-image object: 25, order 1
2025-09-13 16:42:52,066 - jwst.assign_wcs.util - INFO - Excluding off-image object: 26, order 1
2025-09-13 16:42:52,078 - jwst.assign_wcs.util - INFO - Excluding off-image object: 27, order 1
2025-09-13 16:42:52,090 - jwst.assign_wcs.util - INFO - Excluding off-image object: 28, order 1
2025-09-13 16:42:52,102 - jwst.assign_wcs.util - INFO - Excluding off-image object: 29, order 1
2025-09-13 16:42:52,114 - jwst.assign_wcs.util - INFO - Excluding off-image object: 30, order 1
2025-09-13 16:42:52,122 - jwst.assign_wcs.util - INFO - Excluding off-image object: 31, order 1
2025-09-13 16:42:52,134 - jwst.assign_wcs.util - INFO - Excluding off-image object: 32, order 1
2025-09-13 16:42:52,143 - jwst.assign_wcs.util - INFO - Excluding off-image object: 33, order 1
2025-09-13 16:42:52,155 - jwst.assign_wcs.util - INFO - Excluding off-image object: 34, order 1
2025-09-13 16:42:52,167 - jwst.assign_wcs.util - INFO - Excluding off-image object: 35, order 1
2025-09-13 16:42:52,176 - jwst.assign_wcs.util - INFO - Excluding off-image object: 36, order 1
2025-09-13 16:42:52,187 - jwst.assign_wcs.util - INFO - Excluding off-image object: 37, order 1
2025-09-13 16:42:52,196 - jwst.assign_wcs.util - INFO - Excluding off-image object: 38, order 1
2025-09-13 16:42:52,208 - jwst.assign_wcs.util - INFO - Excluding off-image object: 39, order 1
2025-09-13 16:42:52,222 - jwst.assign_wcs.util - INFO - Excluding off-image object: 40, order 1
2025-09-13 16:42:52,234 - jwst.assign_wcs.util - INFO - Excluding off-image object: 41, order 1
2025-09-13 16:42:52,243 - jwst.assign_wcs.util - INFO - Excluding off-image object: 42, order 1
2025-09-13 16:42:52,252 - jwst.assign_wcs.util - INFO - Excluding off-image object: 43, order 1
2025-09-13 16:42:52,265 - jwst.assign_wcs.util - INFO - Excluding off-image object: 44, order 1
2025-09-13 16:42:52,277 - jwst.assign_wcs.util - INFO - Excluding off-image object: 45, order 1
2025-09-13 16:42:52,286 - jwst.assign_wcs.util - INFO - Excluding off-image object: 46, order 1
2025-09-13 16:42:52,297 - jwst.assign_wcs.util - INFO - Excluding off-image object: 47, order 1
2025-09-13 16:42:52,306 - jwst.assign_wcs.util - INFO - Excluding off-image object: 48, order 1
2025-09-13 16:42:52,318 - jwst.assign_wcs.util - INFO - Excluding off-image object: 49, order 1
2025-09-13 16:42:52,327 - jwst.assign_wcs.util - INFO - Excluding off-image object: 50, order 1
2025-09-13 16:42:52,335 - jwst.assign_wcs.util - INFO - Excluding off-image object: 51, order 1
2025-09-13 16:42:52,344 - jwst.assign_wcs.util - INFO - Excluding off-image object: 52, order 1
2025-09-13 16:42:52,353 - jwst.assign_wcs.util - INFO - Excluding off-image object: 53, order 1
2025-09-13 16:42:52,365 - jwst.assign_wcs.util - INFO - Excluding off-image object: 54, order 1
2025-09-13 16:42:52,374 - jwst.assign_wcs.util - INFO - Excluding off-image object: 55, order 1
2025-09-13 16:42:52,382 - jwst.assign_wcs.util - INFO - Excluding off-image object: 56, order 1
2025-09-13 16:42:52,394 - jwst.assign_wcs.util - INFO - Excluding off-image object: 57, order 1
2025-09-13 16:42:52,406 - jwst.assign_wcs.util - INFO - Excluding off-image object: 58, order 1
2025-09-13 16:42:52,415 - jwst.assign_wcs.util - INFO - Excluding off-image object: 59, order 1
2025-09-13 16:42:52,424 - jwst.assign_wcs.util - INFO - Excluding off-image object: 60, order 1
2025-09-13 16:42:52,432 - jwst.assign_wcs.util - INFO - Excluding off-image object: 61, order 1
2025-09-13 16:42:52,441 - jwst.assign_wcs.util - INFO - Excluding off-image object: 62, order 1
2025-09-13 16:42:52,453 - jwst.assign_wcs.util - INFO - Excluding off-image object: 63, order 1
2025-09-13 16:42:52,465 - jwst.assign_wcs.util - INFO - Excluding off-image object: 64, order 1
2025-09-13 16:42:52,473 - jwst.assign_wcs.util - INFO - Excluding off-image object: 65, order 1
2025-09-13 16:42:52,485 - jwst.assign_wcs.util - INFO - Excluding off-image object: 66, order 1
2025-09-13 16:42:52,494 - jwst.assign_wcs.util - INFO - Excluding off-image object: 67, order 1
2025-09-13 16:42:52,503 - jwst.assign_wcs.util - INFO - Excluding off-image object: 68, order 1
2025-09-13 16:42:52,515 - jwst.assign_wcs.util - INFO - Excluding off-image object: 69, order 1
2025-09-13 16:42:52,527 - jwst.assign_wcs.util - INFO - Excluding off-image object: 70, order 1
2025-09-13 16:42:52,538 - jwst.assign_wcs.util - INFO - Excluding off-image object: 71, order 1
2025-09-13 16:42:52,547 - jwst.assign_wcs.util - INFO - Excluding off-image object: 72, order 1
2025-09-13 16:42:52,556 - jwst.assign_wcs.util - INFO - Excluding off-image object: 73, order 1
2025-09-13 16:42:52,565 - jwst.assign_wcs.util - INFO - Excluding off-image object: 74, order 1
2025-09-13 16:42:52,575 - jwst.assign_wcs.util - INFO - Excluding off-image object: 75, order 1
2025-09-13 16:42:52,585 - jwst.assign_wcs.util - INFO - Excluding off-image object: 76, order 1
2025-09-13 16:42:52,597 - jwst.assign_wcs.util - INFO - Excluding off-image object: 77, order 1
2025-09-13 16:42:52,609 - jwst.assign_wcs.util - INFO - Excluding off-image object: 78, order 1
2025-09-13 16:42:52,618 - jwst.assign_wcs.util - INFO - Excluding off-image object: 79, order 1
2025-09-13 16:42:52,629 - jwst.assign_wcs.util - INFO - Excluding off-image object: 80, order 1
2025-09-13 16:42:52,638 - jwst.assign_wcs.util - INFO - Excluding off-image object: 81, order 1
2025-09-13 16:42:52,647 - jwst.assign_wcs.util - INFO - Excluding off-image object: 82, order 1
2025-09-13 16:42:52,659 - jwst.assign_wcs.util - INFO - Excluding off-image object: 83, order 1
2025-09-13 16:42:52,668 - jwst.assign_wcs.util - INFO - Excluding off-image object: 84, order 1
2025-09-13 16:42:52,677 - jwst.assign_wcs.util - INFO - Excluding off-image object: 85, order 1
2025-09-13 16:42:52,686 - jwst.assign_wcs.util - INFO - Excluding off-image object: 86, order 1
2025-09-13 16:42:52,697 - jwst.assign_wcs.util - INFO - Excluding off-image object: 87, order 1
2025-09-13 16:42:52,706 - jwst.assign_wcs.util - INFO - Excluding off-image object: 88, order 1
2025-09-13 16:42:52,716 - jwst.assign_wcs.util - INFO - Excluding off-image object: 89, order 1
2025-09-13 16:42:52,728 - jwst.assign_wcs.util - INFO - Excluding off-image object: 90, order 1
2025-09-13 16:42:52,737 - jwst.assign_wcs.util - INFO - Excluding off-image object: 91, order 1
2025-09-13 16:42:52,749 - jwst.assign_wcs.util - INFO - Excluding off-image object: 92, order 1
2025-09-13 16:42:52,757 - jwst.assign_wcs.util - INFO - Excluding off-image object: 93, order 1
2025-09-13 16:42:52,766 - jwst.assign_wcs.util - INFO - Excluding off-image object: 94, order 1
2025-09-13 16:42:52,775 - jwst.assign_wcs.util - INFO - Excluding off-image object: 95, order 1
2025-09-13 16:42:52,787 - jwst.assign_wcs.util - INFO - Excluding off-image object: 96, order 1
2025-09-13 16:42:52,799 - jwst.assign_wcs.util - INFO - Excluding off-image object: 97, order 1
2025-09-13 16:42:52,808 - jwst.assign_wcs.util - INFO - Excluding off-image object: 98, order 1
2025-09-13 16:42:52,817 - jwst.assign_wcs.util - INFO - Excluding off-image object: 99, order 1
2025-09-13 16:42:52,826 - jwst.assign_wcs.util - INFO - Excluding off-image object: 100, order 1
2025-09-13 16:42:52,835 - jwst.assign_wcs.util - INFO - Excluding off-image object: 101, order 1
2025-09-13 16:42:52,844 - jwst.assign_wcs.util - INFO - Excluding off-image object: 102, order 1
2025-09-13 16:42:52,853 - jwst.assign_wcs.util - INFO - Excluding off-image object: 103, order 1
2025-09-13 16:42:52,862 - jwst.assign_wcs.util - INFO - Excluding off-image object: 104, order 1
2025-09-13 16:42:52,873 - jwst.assign_wcs.util - INFO - Excluding off-image object: 105, order 1
2025-09-13 16:42:52,882 - jwst.assign_wcs.util - INFO - Excluding off-image object: 106, order 1
2025-09-13 16:42:52,891 - jwst.assign_wcs.util - INFO - Excluding off-image object: 107, order 1
2025-09-13 16:42:52,903 - jwst.assign_wcs.util - INFO - Excluding off-image object: 108, order 1
2025-09-13 16:42:52,912 - jwst.assign_wcs.util - INFO - Excluding off-image object: 109, order 1
2025-09-13 16:42:52,923 - jwst.assign_wcs.util - INFO - Excluding off-image object: 110, order 1
2025-09-13 16:42:52,932 - jwst.assign_wcs.util - INFO - Excluding off-image object: 111, order 1
2025-09-13 16:42:52,941 - jwst.assign_wcs.util - INFO - Excluding off-image object: 112, order 1
2025-09-13 16:42:52,950 - jwst.assign_wcs.util - INFO - Excluding off-image object: 113, order 1
2025-09-13 16:42:52,959 - jwst.assign_wcs.util - INFO - Excluding off-image object: 114, order 1
2025-09-13 16:42:52,968 - jwst.assign_wcs.util - INFO - Excluding off-image object: 115, order 1
2025-09-13 16:42:52,977 - jwst.assign_wcs.util - INFO - Excluding off-image object: 116, order 1
2025-09-13 16:42:52,986 - jwst.assign_wcs.util - INFO - Excluding off-image object: 117, order 1
2025-09-13 16:42:52,994 - jwst.assign_wcs.util - INFO - Excluding off-image object: 118, order 1
2025-09-13 16:42:53,004 - jwst.assign_wcs.util - INFO - Excluding off-image object: 119, order 1
2025-09-13 16:42:53,015 - jwst.assign_wcs.util - INFO - Excluding off-image object: 120, order 1
2025-09-13 16:42:53,024 - jwst.assign_wcs.util - INFO - Excluding off-image object: 121, order 1
2025-09-13 16:42:53,036 - jwst.assign_wcs.util - INFO - Excluding off-image object: 122, order 1
2025-09-13 16:42:53,045 - jwst.assign_wcs.util - INFO - Excluding off-image object: 123, order 1
2025-09-13 16:42:53,054 - jwst.assign_wcs.util - INFO - Excluding off-image object: 124, order 1
2025-09-13 16:42:53,062 - jwst.assign_wcs.util - INFO - Excluding off-image object: 125, order 1
2025-09-13 16:42:53,071 - jwst.assign_wcs.util - INFO - Excluding off-image object: 126, order 1
2025-09-13 16:42:53,080 - jwst.assign_wcs.util - INFO - Excluding off-image object: 127, order 1
2025-09-13 16:42:53,089 - jwst.assign_wcs.util - INFO - Excluding off-image object: 128, order 1
2025-09-13 16:42:53,101 - jwst.assign_wcs.util - INFO - Excluding off-image object: 129, order 1
2025-09-13 16:42:53,110 - jwst.assign_wcs.util - INFO - Excluding off-image object: 130, order 1
2025-09-13 16:42:53,119 - jwst.assign_wcs.util - INFO - Excluding off-image object: 131, order 1
2025-09-13 16:42:53,127 - jwst.assign_wcs.util - INFO - Excluding off-image object: 132, order 1
2025-09-13 16:42:53,136 - jwst.assign_wcs.util - INFO - Excluding off-image object: 133, order 1
2025-09-13 16:42:53,145 - jwst.assign_wcs.util - INFO - Excluding off-image object: 134, order 1
2025-09-13 16:42:53,154 - jwst.assign_wcs.util - INFO - Excluding off-image object: 135, order 1
2025-09-13 16:42:53,165 - jwst.assign_wcs.util - INFO - Excluding off-image object: 136, order 1
2025-09-13 16:42:53,177 - jwst.assign_wcs.util - INFO - Excluding off-image object: 137, order 1
2025-09-13 16:42:53,189 - jwst.assign_wcs.util - INFO - Excluding off-image object: 138, order 1
2025-09-13 16:42:53,200 - jwst.assign_wcs.util - INFO - Excluding off-image object: 139, order 1
2025-09-13 16:42:53,209 - jwst.assign_wcs.util - INFO - Excluding off-image object: 140, order 1
2025-09-13 16:42:53,218 - jwst.assign_wcs.util - INFO - Excluding off-image object: 141, order 1
2025-09-13 16:42:53,229 - jwst.assign_wcs.util - INFO - Excluding off-image object: 142, order 1
2025-09-13 16:42:53,238 - jwst.assign_wcs.util - INFO - Excluding off-image object: 143, order 1
2025-09-13 16:42:53,253 - jwst.assign_wcs.util - INFO - Excluding off-image object: 144, order 1
2025-09-13 16:42:53,264 - jwst.assign_wcs.util - INFO - Excluding off-image object: 145, order 1
2025-09-13 16:42:53,273 - jwst.assign_wcs.util - INFO - Excluding off-image object: 146, order 1
2025-09-13 16:42:53,285 - jwst.assign_wcs.util - INFO - Excluding off-image object: 147, order 1
2025-09-13 16:42:53,294 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 148 order: 1
2025-09-13 16:42:53,303 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 149 order: 1
2025-09-13 16:42:53,311 - jwst.assign_wcs.util - INFO - Excluding off-image object: 150, order 1
2025-09-13 16:42:53,320 - jwst.assign_wcs.util - INFO - Excluding off-image object: 151, order 1
2025-09-13 16:42:53,332 - jwst.assign_wcs.util - INFO - Excluding off-image object: 152, order 1
2025-09-13 16:42:53,343 - jwst.assign_wcs.util - INFO - Excluding off-image object: 153, order 1
2025-09-13 16:42:53,352 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 154 order: 1
2025-09-13 16:42:53,364 - jwst.assign_wcs.util - INFO - Excluding off-image object: 155, order 1
2025-09-13 16:42:53,373 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 156 order: 1
2025-09-13 16:42:53,561 - jwst.assign_wcs.util - INFO - Excluding off-image object: 177, order 1
2025-09-13 16:42:53,579 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 179 order: 1
2025-09-13 16:42:53,599 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 181 order: 1
2025-09-13 16:42:53,647 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 186 order: 1
2025-09-13 16:42:53,688 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 190 order: 1
2025-09-13 16:42:53,755 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 198 order: 1
2025-09-13 16:42:53,776 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 200 order: 1
2025-09-13 16:42:53,801 - jwst.assign_wcs.util - INFO - Excluding off-image object: 203, order 1
2025-09-13 16:42:53,828 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 206 order: 1
2025-09-13 16:42:53,837 - jwst.assign_wcs.util - INFO - Excluding off-image object: 207, order 1
2025-09-13 16:42:53,946 - jwst.assign_wcs.util - INFO - Excluding off-image object: 219, order 1
2025-09-13 16:42:54,000 - jwst.assign_wcs.util - INFO - Excluding off-image object: 224, order 1
2025-09-13 16:42:54,045 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 229 order: 1
2025-09-13 16:42:54,065 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 231 order: 1
2025-09-13 16:42:54,209 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 247 order: 1
2025-09-13 16:42:54,218 - jwst.assign_wcs.util - INFO - Excluding off-image object: 248, order 1
2025-09-13 16:42:54,227 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 249 order: 1
2025-09-13 16:42:54,493 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 278 order: 1
2025-09-13 16:42:54,542 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 283 order: 1
2025-09-13 16:42:54,660 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 296 order: 1
2025-09-13 16:42:54,735 - jwst.assign_wcs.util - INFO - Excluding off-image object: 304, order 1
2025-09-13 16:42:54,747 - jwst.assign_wcs.util - INFO - Excluding off-image object: 305, order 1
2025-09-13 16:42:54,759 - jwst.assign_wcs.util - INFO - Excluding off-image object: 306, order 1
2025-09-13 16:42:54,919 - jwst.assign_wcs.util - INFO - Excluding off-image object: 324, order 1
2025-09-13 16:42:54,968 - jwst.assign_wcs.util - INFO - Excluding off-image object: 329, order 1
2025-09-13 16:42:54,977 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 330 order: 1
2025-09-13 16:42:55,227 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 357 order: 1
2025-09-13 16:42:55,239 - jwst.assign_wcs.util - INFO - Excluding off-image object: 358, order 1
2025-09-13 16:42:55,265 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 361 order: 1
2025-09-13 16:42:55,302 - jwst.assign_wcs.util - INFO - Excluding off-image object: 365, order 1
2025-09-13 16:42:55,353 - jwst.assign_wcs.util - INFO - Excluding off-image object: 370, order 1
2025-09-13 16:42:55,365 - jwst.assign_wcs.util - INFO - Excluding off-image object: 371, order 1
2025-09-13 16:42:55,408 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 376 order: 1
2025-09-13 16:42:55,520 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 388 order: 1
2025-09-13 16:42:55,854 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 423 order: 1
2025-09-13 16:42:56,061 - jwst.assign_wcs.util - INFO - Excluding off-image object: 445, order 1
2025-09-13 16:42:56,096 - jwst.assign_wcs.util - INFO - Excluding off-image object: 449, order 1
2025-09-13 16:42:56,284 - jwst.assign_wcs.util - INFO - Excluding off-image object: 469, order 1
2025-09-13 16:42:56,427 - jwst.assign_wcs.util - INFO - Excluding off-image object: 485, order 1
2025-09-13 16:42:56,448 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 487 order: 1
2025-09-13 16:42:56,555 - jwst.assign_wcs.util - INFO - Excluding off-image object: 499, order 1
2025-09-13 16:42:57,198 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 569 order: 1
2025-09-13 16:42:57,315 - jwst.assign_wcs.util - INFO - Excluding off-image object: 582, order 1
2025-09-13 16:42:57,494 - jwst.assign_wcs.util - INFO - Excluding off-image object: 601, order 1
2025-09-13 16:42:57,568 - jwst.assign_wcs.util - INFO - Excluding off-image object: 609, order 1
2025-09-13 16:42:57,580 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 610 order: 1
2025-09-13 16:42:57,764 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 629 order: 1
2025-09-13 16:42:57,937 - jwst.assign_wcs.util - INFO - Excluding off-image object: 647, order 1
2025-09-13 16:42:58,066 - jwst.assign_wcs.util - INFO - Excluding off-image object: 660, order 1
2025-09-13 16:42:58,104 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 664 order: 1
2025-09-13 16:42:58,116 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 665 order: 1
2025-09-13 16:42:58,168 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 670 order: 1
2025-09-13 16:42:58,195 - jwst.assign_wcs.util - INFO - Excluding off-image object: 673, order 1
2025-09-13 16:42:58,333 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 688 order: 1
2025-09-13 16:42:58,378 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 693 order: 1
2025-09-13 16:42:58,406 - jwst.assign_wcs.util - INFO - Excluding off-image object: 696, order 1
2025-09-13 16:42:58,435 - jwst.assign_wcs.util - INFO - Excluding off-image object: 699, order 1
2025-09-13 16:42:58,601 - jwst.assign_wcs.util - INFO - Excluding off-image object: 716, order 1
2025-09-13 16:42:58,675 - jwst.assign_wcs.util - INFO - Excluding off-image object: 724, order 1
2025-09-13 16:42:58,731 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 730 order: 1
2025-09-13 16:42:58,783 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 736 order: 1
2025-09-13 16:42:58,804 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 738 order: 1
2025-09-13 16:42:58,839 - jwst.assign_wcs.util - INFO - Excluding off-image object: 742, order 1
2025-09-13 16:42:58,848 - jwst.assign_wcs.util - INFO - Excluding off-image object: 743, order 1
2025-09-13 16:42:58,973 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 757 order: 1
2025-09-13 16:42:59,002 - jwst.assign_wcs.util - INFO - Excluding off-image object: 760, order 1
2025-09-13 16:42:59,109 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 771 order: 1
2025-09-13 16:42:59,189 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 780 order: 1
2025-09-13 16:42:59,390 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 803 order: 1
2025-09-13 16:42:59,556 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 821 order: 1
2025-09-13 16:42:59,640 - jwst.assign_wcs.util - INFO - Excluding off-image object: 830, order 1
2025-09-13 16:42:59,669 - jwst.assign_wcs.util - INFO - Excluding off-image object: 833, order 1
2025-09-13 16:42:59,768 - jwst.assign_wcs.util - INFO - Excluding off-image object: 844, order 1
2025-09-13 16:42:59,850 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 853 order: 1
2025-09-13 16:42:59,859 - jwst.assign_wcs.util - INFO - Excluding off-image object: 854, order 1
2025-09-13 16:43:00,087 - jwst.assign_wcs.util - INFO - Excluding off-image object: 878, order 1
2025-09-13 16:43:00,236 - jwst.assign_wcs.util - INFO - Excluding off-image object: 894, order 1
2025-09-13 16:43:00,309 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 902 order: 1
2025-09-13 16:43:00,379 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 910 order: 1
2025-09-13 16:43:00,441 - jwst.assign_wcs.util - INFO - Excluding off-image object: 917, order 1
2025-09-13 16:43:00,467 - jwst.assign_wcs.util - INFO - Excluding off-image object: 920, order 1
2025-09-13 16:43:00,518 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 926 order: 1
2025-09-13 16:43:00,722 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 949 order: 1
2025-09-13 16:43:00,771 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 954 order: 1
2025-09-13 16:43:00,994 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 979 order: 1
2025-09-13 16:43:01,053 - jwst.assign_wcs.util - INFO - Excluding off-image object: 986, order 1
2025-09-13 16:43:01,123 - jwst.assign_wcs.util - INFO - Excluding off-image object: 994, order 1
2025-09-13 16:43:01,185 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1001, order 1
2025-09-13 16:43:01,194 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1002 order: 1
2025-09-13 16:43:01,264 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1010 order: 1
2025-09-13 16:43:01,276 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1011 order: 1
2025-09-13 16:43:01,285 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1012 order: 1
2025-09-13 16:43:01,313 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1015, order 1
2025-09-13 16:43:01,341 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1018, order 1
2025-09-13 16:43:01,360 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1020, order 1
2025-09-13 16:43:01,445 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1029 order: 1
2025-09-13 16:43:01,493 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1034, order 1
2025-09-13 16:43:01,630 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1049 order: 1
2025-09-13 16:43:01,651 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1051 order: 1
2025-09-13 16:43:01,668 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1053 order: 1
2025-09-13 16:43:01,997 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1089 order: 1
2025-09-13 16:43:02,036 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1093, order 1
2025-09-13 16:43:02,076 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1097, order 1
2025-09-13 16:43:02,129 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1103, order 1
2025-09-13 16:43:02,199 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1110, order 1
2025-09-13 16:43:02,337 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1125 order: 1
2025-09-13 16:43:02,483 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1142 order: 1
2025-09-13 16:43:02,530 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1147 order: 1
2025-09-13 16:43:02,591 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1154, order 1
2025-09-13 16:43:02,623 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1157, order 1
2025-09-13 16:43:02,654 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1160 order: 1
2025-09-13 16:43:02,730 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1169, order 1
2025-09-13 16:43:02,764 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1173, order 1
2025-09-13 16:43:02,817 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1179, order 1
2025-09-13 16:43:02,970 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1196 order: 1
2025-09-13 16:43:03,024 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1202, order 1
2025-09-13 16:43:03,033 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1203 order: 1
2025-09-13 16:43:03,053 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1205, order 1
2025-09-13 16:43:03,110 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1211, order 1
2025-09-13 16:43:03,194 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1220 order: 1
2025-09-13 16:43:03,223 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1223, order 1
2025-09-13 16:43:03,268 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1228, order 1
2025-09-13 16:43:03,305 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1232 order: 1
2025-09-13 16:43:03,315 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1233, order 1
2025-09-13 16:43:03,400 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1242 order: 1
2025-09-13 16:43:03,617 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1265 order: 1
2025-09-13 16:43:03,802 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1286, order 1
2025-09-13 16:43:03,853 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1291 order: 1
2025-09-13 16:43:03,882 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1294 order: 1
2025-09-13 16:43:03,907 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1297 order: 1
2025-09-13 16:43:03,992 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1306 order: 1
2025-09-13 16:43:04,121 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1320, order 1
2025-09-13 16:43:04,153 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1323, order 1
2025-09-13 16:43:04,502 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1361 order: 1
2025-09-13 16:43:04,633 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1374 order: 1
2025-09-13 16:43:04,682 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1379, order 1
2025-09-13 16:43:04,739 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1385 order: 1
2025-09-13 16:43:04,798 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1392 order: 1
2025-09-13 16:43:04,892 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1402 order: 1
2025-09-13 16:43:05,095 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1424 order: 1
2025-09-13 16:43:05,108 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1425, order 1
2025-09-13 16:43:05,260 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1441, order 1
2025-09-13 16:43:05,298 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1445 order: 1
2025-09-13 16:43:05,332 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1449 order: 1
2025-09-13 16:43:05,433 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1460 order: 1
2025-09-13 16:43:05,594 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1476 order: 1
2025-09-13 16:43:05,633 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1480 order: 1
2025-09-13 16:43:05,698 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1487, order 1
2025-09-13 16:43:05,740 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1491 order: 1
2025-09-13 16:43:05,784 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1496 order: 1
2025-09-13 16:43:05,811 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1499 order: 1
2025-09-13 16:43:05,835 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1501 order: 1
2025-09-13 16:43:05,847 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1502 order: 1
2025-09-13 16:43:05,851 - jwst.assign_wcs.util - INFO - Total of 100 grism objects defined
2025-09-13 16:43:05,878 - jwst.extract_2d.grisms - INFO - Grism object list created from source catalog: jw02079-o004_niriss_clear-f200w_cat.ecsv
2025-09-13 16:43:05,880 - jwst.extract_2d.grisms - INFO - Extracting 100 grism objects
2025-09-13 16:43:05,990 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 522 order: 1:
2025-09-13 16:43:05,991 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:504, xmax:774), (ymin:528, ymax:674)
2025-09-13 16:43:06,178 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 796 order: 1:
2025-09-13 16:43:06,179 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1685, xmax:1901), (ymin:953, ymax:1048)
2025-09-13 16:43:06,361 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 1479 order: 1:
2025-09-13 16:43:06,362 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:30, xmax:256), (ymin:1989, ymax:2045)
2025-09-13 16:43:06,541 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 214 order: 1:
2025-09-13 16:43:06,542 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:199, xmax:406), (ymin:99, ymax:204)
2025-09-13 16:43:06,717 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 693 order: 1:
2025-09-13 16:43:06,717 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:0, xmax:173), (ymin:783, ymax:858)
2025-09-13 16:43:06,896 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 1120 order: 1:
2025-09-13 16:43:06,897 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:398, xmax:630), (ymin:1412, ymax:1480)
2025-09-13 16:43:07,074 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 1257 order: 1:
2025-09-13 16:43:07,074 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1339, xmax:1565), (ymin:1607, ymax:1683)
2025-09-13 16:43:07,694 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 766 order: 1:
2025-09-13 16:43:07,695 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:841, xmax:1015), (ymin:911, ymax:1013)
2025-09-13 16:43:07,867 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 606 order: 1:
2025-09-13 16:43:07,867 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:298, xmax:492), (ymin:671, ymax:681)
2025-09-13 16:43:08,035 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 649 order: 1:
2025-09-13 16:43:08,035 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1426, xmax:1638), (ymin:713, ymax:807)
2025-09-13 16:43:08,212 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 982 order: 1:
2025-09-13 16:43:08,213 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:287, xmax:459), (ymin:1209, ymax:1263)
2025-09-13 16:43:08,388 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 1364 order: 1:
2025-09-13 16:43:08,388 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1250, xmax:1416), (ymin:1781, ymax:1840)
2025-09-13 16:43:08,566 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 898 order: 1:
2025-09-13 16:43:08,567 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1290, xmax:1457), (ymin:1126, ymax:1136)
2025-09-13 16:43:08,740 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 1049 order: 1:
2025-09-13 16:43:08,740 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:0, xmax:19), (ymin:1307, ymax:1382)
2025-09-13 16:43:08,915 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 732 order: 1:
2025-09-13 16:43:08,916 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:385, xmax:573), (ymin:853, ymax:896)
2025-09-13 16:43:09,092 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 189 order: 1:
2025-09-13 16:43:09,093 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1004, xmax:1174), (ymin:66, ymax:112)
2025-09-13 16:43:09,270 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 881 order: 1:
2025-09-13 16:43:09,271 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1006, xmax:1198), (ymin:1091, ymax:1101)
2025-09-13 16:43:09,443 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 966 order: 1:
2025-09-13 16:43:09,444 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1274, xmax:1451), (ymin:1201, ymax:1259)
2025-09-13 16:43:09,619 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 914 order: 1:
2025-09-13 16:43:09,619 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1654, xmax:1819), (ymin:1121, ymax:1152)
2025-09-13 16:43:09,793 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 1084 order: 1:
2025-09-13 16:43:09,794 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1678, xmax:1852), (ymin:1388, ymax:1398)
2025-09-13 16:43:09,968 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 540 order: 1:
2025-09-13 16:43:09,969 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1570, xmax:1754), (ymin:555, ymax:626)
2025-09-13 16:43:10,151 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 1476 order: 1:
2025-09-13 16:43:10,152 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:0, xmax:43), (ymin:1987, ymax:2045)
2025-09-13 16:43:10,326 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 1142 order: 1:
2025-09-13 16:43:10,327 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:0, xmax:126), (ymin:1442, ymax:1487)
2025-09-13 16:43:10,501 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 220 order: 1:
2025-09-13 16:43:10,501 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:15, xmax:185), (ymin:125, ymax:135)
2025-09-13 16:43:10,677 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 289 order: 1:
2025-09-13 16:43:10,678 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1746, xmax:1916), (ymin:212, ymax:247)
2025-09-13 16:43:10,854 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 934 order: 1:
2025-09-13 16:43:10,854 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:566, xmax:739), (ymin:1146, ymax:1193)
2025-09-13 16:43:11,030 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 1219 order: 1:
2025-09-13 16:43:11,031 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:803, xmax:972), (ymin:1558, ymax:1618)
2025-09-13 16:43:11,205 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 927 order: 1:
2025-09-13 16:43:11,206 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:665, xmax:840), (ymin:1133, ymax:1176)
2025-09-13 16:43:11,384 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 1417 order: 1:
2025-09-13 16:43:11,385 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:14, xmax:176), (ymin:1876, ymax:1914)
2025-09-13 16:43:11,560 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 567 order: 1:
2025-09-13 16:43:11,561 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1533, xmax:1701), (ymin:603, ymax:651)
2025-09-13 16:43:11,738 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 1296 order: 1:
2025-09-13 16:43:11,739 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:508, xmax:673), (ymin:1661, ymax:1703)
2025-09-13 16:43:11,916 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 1412 order: 1:
2025-09-13 16:43:11,917 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:729, xmax:892), (ymin:1872, ymax:1910)
2025-09-13 16:43:12,092 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 654 order: 1:
2025-09-13 16:43:12,093 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1640, xmax:1827), (ymin:722, ymax:781)
2025-09-13 16:43:12,272 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 1029 order: 1:
2025-09-13 16:43:12,273 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:0, xmax:182), (ymin:1273, ymax:1328)
2025-09-13 16:43:12,451 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 553 order: 1:
2025-09-13 16:43:12,451 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:306, xmax:476), (ymin:570, ymax:605)
2025-09-13 16:43:12,625 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 1387 order: 1:
2025-09-13 16:43:12,626 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1862, xmax:2022), (ymin:1826, ymax:1866)
2025-09-13 16:43:13,391 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 422 order: 1:
2025-09-13 16:43:13,392 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1416, xmax:1570), (ymin:379, ymax:407)
2025-09-13 16:43:13,569 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 821 order: 1:
2025-09-13 16:43:13,570 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:0, xmax:139), (ymin:972, ymax:1014)
2025-09-13 16:43:13,747 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 682 order: 1:
2025-09-13 16:43:13,748 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:834, xmax:999), (ymin:777, ymax:826)
2025-09-13 16:43:13,925 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 1140 order: 1:
2025-09-13 16:43:13,926 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1497, xmax:1668), (ymin:1449, ymax:1491)
2025-09-13 16:43:14,104 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 1388 order: 1:
2025-09-13 16:43:14,104 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1633, xmax:1807), (ymin:1827, ymax:1885)
2025-09-13 16:43:14,279 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 759 order: 1:
2025-09-13 16:43:14,280 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1031, xmax:1198), (ymin:903, ymax:942)
2025-09-13 16:43:14,455 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 1407 order: 1:
2025-09-13 16:43:14,456 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1127, xmax:1292), (ymin:1856, ymax:1891)
2025-09-13 16:43:14,631 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 1194 order: 1:
2025-09-13 16:43:14,631 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1553, xmax:1717), (ymin:1511, ymax:1540)
2025-09-13 16:43:14,803 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 712 order: 1:
2025-09-13 16:43:14,803 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1168, xmax:1332), (ymin:823, ymax:856)
2025-09-13 16:43:14,976 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 539 order: 1:
2025-09-13 16:43:14,977 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1479, xmax:1629), (ymin:555, ymax:597)
2025-09-13 16:43:15,151 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 1008 order: 1:
2025-09-13 16:43:15,152 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:890, xmax:1045), (ymin:1252, ymax:1282)
2025-09-13 16:43:15,323 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 347 order: 1:
2025-09-13 16:43:15,324 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:569, xmax:723), (ymin:286, ymax:296)
2025-09-13 16:43:15,494 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 276 order: 1:
2025-09-13 16:43:15,495 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1163, xmax:1327), (ymin:188, ymax:232)
2025-09-13 16:43:15,668 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 605 order: 1:
2025-09-13 16:43:15,669 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:199, xmax:345), (ymin:649, ymax:659)
2025-09-13 16:43:15,842 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 922 order: 1:
2025-09-13 16:43:15,843 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1580, xmax:1733), (ymin:1129, ymax:1159)
2025-09-13 16:43:16,020 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 736 order: 1:
2025-09-13 16:43:16,020 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1905, xmax:2048), (ymin:867, ymax:890)
2025-09-13 16:43:16,193 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 1423 order: 1:
2025-09-13 16:43:16,194 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:70, xmax:226), (ymin:1897, ymax:1928)
2025-09-13 16:43:16,370 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 800 order: 1:
2025-09-13 16:43:16,371 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:656, xmax:807), (ymin:953, ymax:979)
2025-09-13 16:43:16,548 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 873 order: 1:
2025-09-13 16:43:16,549 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1871, xmax:2016), (ymin:1061, ymax:1088)
2025-09-13 16:43:16,728 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 385 order: 1:
2025-09-13 16:43:16,729 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:293, xmax:457), (ymin:319, ymax:340)
2025-09-13 16:43:16,903 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 557 order: 1:
2025-09-13 16:43:16,904 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:191, xmax:352), (ymin:582, ymax:620)
2025-09-13 16:43:17,083 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 719 order: 1:
2025-09-13 16:43:17,084 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1454, xmax:1601), (ymin:834, ymax:863)
2025-09-13 16:43:17,262 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 389 order: 1:
2025-09-13 16:43:17,263 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:349, xmax:504), (ymin:324, ymax:353)
2025-09-13 16:43:17,440 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 733 order: 1:
2025-09-13 16:43:17,441 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1723, xmax:1898), (ymin:863, ymax:906)
2025-09-13 16:43:17,620 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 1442 order: 1:
2025-09-13 16:43:17,621 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:545, xmax:712), (ymin:1932, ymax:1975)
2025-09-13 16:43:17,796 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 417 order: 1:
2025-09-13 16:43:17,797 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:803, xmax:951), (ymin:366, ymax:394)
2025-09-13 16:43:17,971 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 630 order: 1:
2025-09-13 16:43:17,972 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1769, xmax:1911), (ymin:682, ymax:692)
2025-09-13 16:43:18,145 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 925 order: 1:
2025-09-13 16:43:18,146 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:284, xmax:450), (ymin:1125, ymax:1158)
2025-09-13 16:43:18,321 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 527 order: 1:
2025-09-13 16:43:18,322 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1762, xmax:1912), (ymin:541, ymax:576)
2025-09-13 16:43:18,498 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 439 order: 1:
2025-09-13 16:43:18,498 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:665, xmax:825), (ymin:407, ymax:417)
2025-09-13 16:43:19,308 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 1253 order: 1:
2025-09-13 16:43:19,308 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:114, xmax:261), (ymin:1597, ymax:1629)
2025-09-13 16:43:19,486 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 1162 order: 1:
2025-09-13 16:43:19,487 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:796, xmax:940), (ymin:1468, ymax:1487)
2025-09-13 16:43:19,662 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 1457 order: 1:
2025-09-13 16:43:19,663 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:149, xmax:297), (ymin:1957, ymax:1981)
2025-09-13 16:43:19,841 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 694 order: 1:
2025-09-13 16:43:19,842 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:233, xmax:400), (ymin:785, ymax:807)
2025-09-13 16:43:20,015 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 1266 order: 1:
2025-09-13 16:43:20,016 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:698, xmax:858), (ymin:1619, ymax:1646)
2025-09-13 16:43:20,192 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 298 order: 1:
2025-09-13 16:43:20,193 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1032, xmax:1187), (ymin:217, ymax:240)
2025-09-13 16:43:20,371 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 516 order: 1:
2025-09-13 16:43:20,372 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:463, xmax:616), (ymin:519, ymax:553)
2025-09-13 16:43:20,554 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 973 order: 1:
2025-09-13 16:43:20,555 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:439, xmax:585), (ymin:1202, ymax:1222)
2025-09-13 16:43:20,737 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 180 order: 1:
2025-09-13 16:43:20,737 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1362, xmax:1526), (ymin:55, ymax:87)
2025-09-13 16:43:20,919 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 980 order: 1:
2025-09-13 16:43:20,919 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1346, xmax:1508), (ymin:1214, ymax:1244)
2025-09-13 16:43:21,097 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 263 order: 1:
2025-09-13 16:43:21,097 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:817, xmax:978), (ymin:159, ymax:184)
2025-09-13 16:43:21,272 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 493 order: 1:
2025-09-13 16:43:21,273 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1399, xmax:1551), (ymin:486, ymax:515)
2025-09-13 16:43:21,447 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 981 order: 1:
2025-09-13 16:43:21,448 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1717, xmax:1859), (ymin:1216, ymax:1238)
2025-09-13 16:43:21,623 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 1371 order: 1:
2025-09-13 16:43:21,624 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:613, xmax:760), (ymin:1788, ymax:1811)
2025-09-13 16:43:21,796 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 536 order: 1:
2025-09-13 16:43:21,797 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:366, xmax:512), (ymin:544, ymax:577)
2025-09-13 16:43:21,970 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 749 order: 1:
2025-09-13 16:43:21,971 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1474, xmax:1622), (ymin:890, ymax:912)
2025-09-13 16:43:22,141 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 345 order: 1:
2025-09-13 16:43:22,141 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:840, xmax:984), (ymin:274, ymax:296)
2025-09-13 16:43:22,314 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 721 order: 1:
2025-09-13 16:43:22,315 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:108, xmax:249), (ymin:830, ymax:840)
2025-09-13 16:43:22,485 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 387 order: 1:
2025-09-13 16:43:22,486 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1374, xmax:1520), (ymin:328, ymax:347)
2025-09-13 16:43:22,663 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 505 order: 1:
2025-09-13 16:43:22,664 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1429, xmax:1573), (ymin:516, ymax:537)
2025-09-13 16:43:22,842 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 566 order: 1:
2025-09-13 16:43:22,843 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1104, xmax:1250), (ymin:601, ymax:637)
2025-09-13 16:43:23,017 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 772 order: 1:
2025-09-13 16:43:23,018 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1606, xmax:1754), (ymin:919, ymax:944)
2025-09-13 16:43:23,194 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 722 order: 1:
2025-09-13 16:43:23,194 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:379, xmax:534), (ymin:830, ymax:856)
2025-09-13 16:43:23,373 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 872 order: 1:
2025-09-13 16:43:23,374 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1411, xmax:1558), (ymin:1062, ymax:1072)
2025-09-13 16:43:23,549 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 933 order: 1:
2025-09-13 16:43:23,550 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:15, xmax:175), (ymin:1142, ymax:1167)
2025-09-13 16:43:23,725 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 1128 order: 1:
2025-09-13 16:43:23,726 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1680, xmax:1818), (ymin:1434, ymax:1444)
2025-09-13 16:43:23,899 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 1282 order: 1:
2025-09-13 16:43:23,900 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:787, xmax:944), (ymin:1650, ymax:1684)
2025-09-13 16:43:24,073 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 274 order: 1:
2025-09-13 16:43:24,074 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:380, xmax:533), (ymin:175, ymax:207)
2025-09-13 16:43:24,249 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 641 order: 1:
2025-09-13 16:43:24,250 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1513, xmax:1664), (ymin:698, ymax:720)
2025-09-13 16:43:24,424 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 543 order: 1:
2025-09-13 16:43:24,424 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:120, xmax:274), (ymin:553, ymax:581)
2025-09-13 16:43:24,599 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 610 order: 1:
2025-09-13 16:43:24,599 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:0, xmax:6), (ymin:667, ymax:677)
2025-09-13 16:43:24,773 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 1188 order: 1:
2025-09-13 16:43:24,773 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:429, xmax:570), (ymin:1499, ymax:1536)
2025-09-13 16:43:24,949 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 533 order: 1:
2025-09-13 16:43:24,949 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1308, xmax:1456), (ymin:546, ymax:567)
2025-09-13 16:43:25,125 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 1342 order: 1:
2025-09-13 16:43:25,125 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1374, xmax:1519), (ymin:1744, ymax:1766)
2025-09-13 16:43:28,419 - jwst.extract_2d.grisms - INFO - Finished extractions
2025-09-13 16:43:28,452 - stpipe.Spec2Pipeline.extract_2d - INFO - Step extract_2d done
2025-09-13 16:43:29,046 - stpipe.Spec2Pipeline.srctype - INFO - Step srctype running with args (<MultiSlitModel from jw02079004003_05101_00003_nis_rate.fits>,).
2025-09-13 16:43:29,053 - jwst.srctype.srctype - INFO - Input EXP_TYPE is NIS_WFSS
2025-09-13 16:43:29,053 - jwst.srctype.srctype - INFO - source_id=522, type=EXTENDED
2025-09-13 16:43:29,054 - jwst.srctype.srctype - INFO - source_id=796, type=EXTENDED
2025-09-13 16:43:29,055 - jwst.srctype.srctype - INFO - source_id=1479, type=EXTENDED
2025-09-13 16:43:29,055 - jwst.srctype.srctype - INFO - source_id=214, type=EXTENDED
2025-09-13 16:43:29,056 - jwst.srctype.srctype - INFO - source_id=693, type=EXTENDED
2025-09-13 16:43:29,056 - jwst.srctype.srctype - INFO - source_id=1120, type=EXTENDED
2025-09-13 16:43:29,057 - jwst.srctype.srctype - INFO - source_id=1257, type=EXTENDED
2025-09-13 16:43:29,057 - jwst.srctype.srctype - INFO - source_id=766, type=EXTENDED
2025-09-13 16:43:29,058 - jwst.srctype.srctype - INFO - source_id=606, type=POINT
2025-09-13 16:43:29,059 - jwst.srctype.srctype - INFO - source_id=649, type=EXTENDED
2025-09-13 16:43:29,059 - jwst.srctype.srctype - INFO - source_id=982, type=EXTENDED
2025-09-13 16:43:29,060 - jwst.srctype.srctype - INFO - source_id=1364, type=EXTENDED
2025-09-13 16:43:29,060 - jwst.srctype.srctype - INFO - source_id=898, type=POINT
2025-09-13 16:43:29,061 - jwst.srctype.srctype - INFO - source_id=1049, type=EXTENDED
2025-09-13 16:43:29,061 - jwst.srctype.srctype - INFO - source_id=732, type=EXTENDED
2025-09-13 16:43:29,062 - jwst.srctype.srctype - INFO - source_id=189, type=EXTENDED
2025-09-13 16:43:29,063 - jwst.srctype.srctype - INFO - source_id=881, type=POINT
2025-09-13 16:43:29,064 - jwst.srctype.srctype - INFO - source_id=966, type=EXTENDED
2025-09-13 16:43:29,064 - jwst.srctype.srctype - INFO - source_id=914, type=EXTENDED
2025-09-13 16:43:29,065 - jwst.srctype.srctype - INFO - source_id=1084, type=POINT
2025-09-13 16:43:29,065 - jwst.srctype.srctype - INFO - source_id=540, type=EXTENDED
2025-09-13 16:43:29,066 - jwst.srctype.srctype - INFO - source_id=1476, type=EXTENDED
2025-09-13 16:43:29,066 - jwst.srctype.srctype - INFO - source_id=1142, type=EXTENDED
2025-09-13 16:43:29,067 - jwst.srctype.srctype - INFO - source_id=220, type=POINT
2025-09-13 16:43:29,067 - jwst.srctype.srctype - INFO - source_id=289, type=EXTENDED
2025-09-13 16:43:29,068 - jwst.srctype.srctype - INFO - source_id=934, type=EXTENDED
2025-09-13 16:43:29,068 - jwst.srctype.srctype - INFO - source_id=1219, type=EXTENDED
2025-09-13 16:43:29,069 - jwst.srctype.srctype - INFO - source_id=927, type=EXTENDED
2025-09-13 16:43:29,069 - jwst.srctype.srctype - INFO - source_id=1417, type=EXTENDED
2025-09-13 16:43:29,070 - jwst.srctype.srctype - INFO - source_id=567, type=EXTENDED
2025-09-13 16:43:29,071 - jwst.srctype.srctype - INFO - source_id=1296, type=EXTENDED
2025-09-13 16:43:29,071 - jwst.srctype.srctype - INFO - source_id=1412, type=EXTENDED
2025-09-13 16:43:29,072 - jwst.srctype.srctype - INFO - source_id=654, type=EXTENDED
2025-09-13 16:43:29,072 - jwst.srctype.srctype - INFO - source_id=1029, type=EXTENDED
2025-09-13 16:43:29,073 - jwst.srctype.srctype - INFO - source_id=553, type=EXTENDED
2025-09-13 16:43:29,074 - jwst.srctype.srctype - INFO - source_id=1387, type=EXTENDED
2025-09-13 16:43:29,074 - jwst.srctype.srctype - INFO - source_id=422, type=EXTENDED
2025-09-13 16:43:29,075 - jwst.srctype.srctype - INFO - source_id=821, type=EXTENDED
2025-09-13 16:43:29,075 - jwst.srctype.srctype - INFO - source_id=682, type=EXTENDED
2025-09-13 16:43:29,076 - jwst.srctype.srctype - INFO - source_id=1140, type=EXTENDED
2025-09-13 16:43:29,076 - jwst.srctype.srctype - INFO - source_id=1388, type=EXTENDED
2025-09-13 16:43:29,077 - jwst.srctype.srctype - INFO - source_id=759, type=EXTENDED
2025-09-13 16:43:29,077 - jwst.srctype.srctype - INFO - source_id=1407, type=EXTENDED
2025-09-13 16:43:29,078 - jwst.srctype.srctype - INFO - source_id=1194, type=EXTENDED
2025-09-13 16:43:29,078 - jwst.srctype.srctype - INFO - source_id=712, type=EXTENDED
2025-09-13 16:43:29,079 - jwst.srctype.srctype - INFO - source_id=539, type=EXTENDED
2025-09-13 16:43:29,079 - jwst.srctype.srctype - INFO - source_id=1008, type=EXTENDED
2025-09-13 16:43:29,080 - jwst.srctype.srctype - INFO - source_id=347, type=POINT
2025-09-13 16:43:29,080 - jwst.srctype.srctype - INFO - source_id=276, type=EXTENDED
2025-09-13 16:43:29,081 - jwst.srctype.srctype - INFO - source_id=605, type=POINT
2025-09-13 16:43:29,082 - jwst.srctype.srctype - INFO - source_id=922, type=EXTENDED
2025-09-13 16:43:29,082 - jwst.srctype.srctype - INFO - source_id=736, type=EXTENDED
2025-09-13 16:43:29,083 - jwst.srctype.srctype - INFO - source_id=1423, type=EXTENDED
2025-09-13 16:43:29,083 - jwst.srctype.srctype - INFO - source_id=800, type=EXTENDED
2025-09-13 16:43:29,084 - jwst.srctype.srctype - INFO - source_id=873, type=EXTENDED
2025-09-13 16:43:29,084 - jwst.srctype.srctype - INFO - source_id=385, type=EXTENDED
2025-09-13 16:43:29,085 - jwst.srctype.srctype - INFO - source_id=557, type=EXTENDED
2025-09-13 16:43:29,086 - jwst.srctype.srctype - INFO - source_id=719, type=EXTENDED
2025-09-13 16:43:29,086 - jwst.srctype.srctype - INFO - source_id=389, type=EXTENDED
2025-09-13 16:43:29,087 - jwst.srctype.srctype - INFO - source_id=733, type=EXTENDED
2025-09-13 16:43:29,087 - jwst.srctype.srctype - INFO - source_id=1442, type=EXTENDED
2025-09-13 16:43:29,088 - jwst.srctype.srctype - INFO - source_id=417, type=EXTENDED
2025-09-13 16:43:29,088 - jwst.srctype.srctype - INFO - source_id=630, type=POINT
2025-09-13 16:43:29,089 - jwst.srctype.srctype - INFO - source_id=925, type=EXTENDED
2025-09-13 16:43:29,089 - jwst.srctype.srctype - INFO - source_id=527, type=EXTENDED
2025-09-13 16:43:29,090 - jwst.srctype.srctype - INFO - source_id=439, type=POINT
2025-09-13 16:43:29,090 - jwst.srctype.srctype - INFO - source_id=1253, type=EXTENDED
2025-09-13 16:43:29,091 - jwst.srctype.srctype - INFO - source_id=1162, type=EXTENDED
2025-09-13 16:43:29,091 - jwst.srctype.srctype - INFO - source_id=1457, type=EXTENDED
2025-09-13 16:43:29,092 - jwst.srctype.srctype - INFO - source_id=694, type=EXTENDED
2025-09-13 16:43:29,092 - jwst.srctype.srctype - INFO - source_id=1266, type=EXTENDED
2025-09-13 16:43:29,093 - jwst.srctype.srctype - INFO - source_id=298, type=EXTENDED
2025-09-13 16:43:29,094 - jwst.srctype.srctype - INFO - source_id=516, type=EXTENDED
2025-09-13 16:43:29,094 - jwst.srctype.srctype - INFO - source_id=973, type=EXTENDED
2025-09-13 16:43:29,095 - jwst.srctype.srctype - INFO - source_id=180, type=EXTENDED
2025-09-13 16:43:29,095 - jwst.srctype.srctype - INFO - source_id=980, type=EXTENDED
2025-09-13 16:43:29,096 - jwst.srctype.srctype - INFO - source_id=263, type=EXTENDED
2025-09-13 16:43:29,096 - jwst.srctype.srctype - INFO - source_id=493, type=EXTENDED
2025-09-13 16:43:29,097 - jwst.srctype.srctype - INFO - source_id=981, type=EXTENDED
2025-09-13 16:43:29,097 - jwst.srctype.srctype - INFO - source_id=1371, type=EXTENDED
2025-09-13 16:43:29,098 - jwst.srctype.srctype - INFO - source_id=536, type=EXTENDED
2025-09-13 16:43:29,098 - jwst.srctype.srctype - INFO - source_id=749, type=EXTENDED
2025-09-13 16:43:29,099 - jwst.srctype.srctype - INFO - source_id=345, type=EXTENDED
2025-09-13 16:43:29,099 - jwst.srctype.srctype - INFO - source_id=721, type=POINT
2025-09-13 16:43:29,100 - jwst.srctype.srctype - INFO - source_id=387, type=EXTENDED
2025-09-13 16:43:29,100 - jwst.srctype.srctype - INFO - source_id=505, type=EXTENDED
2025-09-13 16:43:29,101 - jwst.srctype.srctype - INFO - source_id=566, type=EXTENDED
2025-09-13 16:43:29,102 - jwst.srctype.srctype - INFO - source_id=772, type=EXTENDED
2025-09-13 16:43:29,102 - jwst.srctype.srctype - INFO - source_id=722, type=EXTENDED
2025-09-13 16:43:29,103 - jwst.srctype.srctype - INFO - source_id=872, type=POINT
2025-09-13 16:43:29,103 - jwst.srctype.srctype - INFO - source_id=933, type=EXTENDED
2025-09-13 16:43:29,105 - jwst.srctype.srctype - INFO - source_id=1128, type=POINT
2025-09-13 16:43:29,105 - jwst.srctype.srctype - INFO - source_id=1282, type=EXTENDED
2025-09-13 16:43:29,106 - jwst.srctype.srctype - INFO - source_id=274, type=EXTENDED
2025-09-13 16:43:29,106 - jwst.srctype.srctype - INFO - source_id=641, type=EXTENDED
2025-09-13 16:43:29,107 - jwst.srctype.srctype - INFO - source_id=543, type=EXTENDED
2025-09-13 16:43:29,107 - jwst.srctype.srctype - INFO - source_id=610, type=POINT
2025-09-13 16:43:29,108 - jwst.srctype.srctype - INFO - source_id=1188, type=EXTENDED
2025-09-13 16:43:29,108 - jwst.srctype.srctype - INFO - source_id=533, type=EXTENDED
2025-09-13 16:43:29,109 - jwst.srctype.srctype - INFO - source_id=1342, type=EXTENDED
2025-09-13 16:43:29,111 - stpipe.Spec2Pipeline.srctype - INFO - Step srctype done
2025-09-13 16:43:29,713 - stpipe.Spec2Pipeline.straylight - INFO - Step straylight running with args (<MultiSlitModel from jw02079004003_05101_00003_nis_rate.fits>,).
2025-09-13 16:43:29,714 - stpipe.Spec2Pipeline.straylight - INFO - Step skipped.
2025-09-13 16:43:30,300 - stpipe.Spec2Pipeline.fringe - INFO - Step fringe running with args (<MultiSlitModel from jw02079004003_05101_00003_nis_rate.fits>,).
2025-09-13 16:43:30,300 - stpipe.Spec2Pipeline.fringe - INFO - Step skipped.
2025-09-13 16:43:30,865 - stpipe.Spec2Pipeline.pathloss - INFO - Step pathloss running with args (<MultiSlitModel from jw02079004003_05101_00003_nis_rate.fits>,).
2025-09-13 16:43:30,866 - stpipe.Spec2Pipeline.pathloss - INFO - Step skipped.
2025-09-13 16:43:31,428 - stpipe.Spec2Pipeline.barshadow - INFO - Step barshadow running with args (<MultiSlitModel from jw02079004003_05101_00003_nis_rate.fits>,).
2025-09-13 16:43:31,429 - stpipe.Spec2Pipeline.barshadow - INFO - Step skipped.
2025-09-13 16:43:31,992 - stpipe.Spec2Pipeline.wfss_contam - INFO - Step wfss_contam running with args (<MultiSlitModel from jw02079004003_05101_00003_nis_rate.fits>,).
2025-09-13 16:43:31,993 - stpipe.Spec2Pipeline.wfss_contam - INFO - Step skipped.
2025-09-13 16:43:32,584 - stpipe.Spec2Pipeline.photom - INFO - Step photom running with args (<MultiSlitModel from jw02079004003_05101_00003_nis_rate.fits>,).
2025-09-13 16:43:32,630 - stpipe.Spec2Pipeline.photom - INFO - Using photom reference file: /home/runner/crds/references/jwst/niriss/jwst_niriss_photom_0041.fits
2025-09-13 16:43:32,631 - stpipe.Spec2Pipeline.photom - INFO - Using area reference file: N/A
2025-09-13 16:43:35,775 - jwst.photom.photom - INFO - Using instrument: NIRISS
2025-09-13 16:43:35,775 - jwst.photom.photom - INFO - detector: NIS
2025-09-13 16:43:35,776 - jwst.photom.photom - INFO - exp_type: NIS_WFSS
2025-09-13 16:43:35,777 - jwst.photom.photom - INFO - filter: GR150C
2025-09-13 16:43:35,777 - jwst.photom.photom - INFO - pupil: F200W
2025-09-13 16:43:35,796 - jwst.photom.photom - INFO - Attempting to obtain PIXAR_SR and PIXAR_A2 values from PHOTOM reference file.
2025-09-13 16:43:35,797 - jwst.photom.photom - INFO - Values for PIXAR_SR and PIXAR_A2 obtained from PHOTOM reference file.
2025-09-13 16:43:35,831 - jwst.photom.photom - INFO - Working on slit 522, order 1
2025-09-13 16:43:35,832 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:43:35,837 - jwst.photom.photom - INFO - Working on slit 796, order 1
2025-09-13 16:43:35,838 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:43:35,843 - jwst.photom.photom - INFO - Working on slit 1479, order 1
2025-09-13 16:43:35,843 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:43:35,847 - jwst.photom.photom - INFO - Working on slit 214, order 1
2025-09-13 16:43:35,848 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:43:35,852 - jwst.photom.photom - INFO - Working on slit 693, order 1
2025-09-13 16:43:35,853 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:43:35,857 - jwst.photom.photom - INFO - Working on slit 1120, order 1
2025-09-13 16:43:35,858 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:43:35,862 - jwst.photom.photom - INFO - Working on slit 1257, order 1
2025-09-13 16:43:35,863 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:43:35,867 - jwst.photom.photom - INFO - Working on slit 766, order 1
2025-09-13 16:43:35,867 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:43:35,872 - jwst.photom.photom - INFO - Working on slit 606, order 1
2025-09-13 16:43:35,872 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:43:35,876 - jwst.photom.photom - INFO - Working on slit 649, order 1
2025-09-13 16:43:35,877 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:43:35,881 - jwst.photom.photom - INFO - Working on slit 982, order 1
2025-09-13 16:43:35,882 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:43:35,885 - jwst.photom.photom - INFO - Working on slit 1364, order 1
2025-09-13 16:43:35,886 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:43:35,890 - jwst.photom.photom - INFO - Working on slit 898, order 1
2025-09-13 16:43:35,891 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:43:35,894 - jwst.photom.photom - INFO - Working on slit 1049, order 1
2025-09-13 16:43:35,895 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:43:35,898 - jwst.photom.photom - INFO - Working on slit 732, order 1
2025-09-13 16:43:35,899 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:43:35,903 - jwst.photom.photom - INFO - Working on slit 189, order 1
2025-09-13 16:43:35,904 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:43:35,907 - jwst.photom.photom - INFO - Working on slit 881, order 1
2025-09-13 16:43:35,908 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:43:35,912 - jwst.photom.photom - INFO - Working on slit 966, order 1
2025-09-13 16:43:35,913 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:43:35,916 - jwst.photom.photom - INFO - Working on slit 914, order 1
2025-09-13 16:43:35,917 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:43:35,921 - jwst.photom.photom - INFO - Working on slit 1084, order 1
2025-09-13 16:43:35,922 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:43:35,925 - jwst.photom.photom - INFO - Working on slit 540, order 1
2025-09-13 16:43:35,926 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:43:35,930 - jwst.photom.photom - INFO - Working on slit 1476, order 1
2025-09-13 16:43:35,931 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:43:35,934 - jwst.photom.photom - INFO - Working on slit 1142, order 1
2025-09-13 16:43:35,935 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:43:35,939 - jwst.photom.photom - INFO - Working on slit 220, order 1
2025-09-13 16:43:35,940 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:43:35,943 - jwst.photom.photom - INFO - Working on slit 289, order 1
2025-09-13 16:43:35,944 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:43:35,948 - jwst.photom.photom - INFO - Working on slit 934, order 1
2025-09-13 16:43:35,949 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:43:35,952 - jwst.photom.photom - INFO - Working on slit 1219, order 1
2025-09-13 16:43:35,953 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:43:35,957 - jwst.photom.photom - INFO - Working on slit 927, order 1
2025-09-13 16:43:35,957 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:43:35,961 - jwst.photom.photom - INFO - Working on slit 1417, order 1
2025-09-13 16:43:35,962 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:43:35,966 - jwst.photom.photom - INFO - Working on slit 567, order 1
2025-09-13 16:43:35,966 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:43:35,971 - jwst.photom.photom - INFO - Working on slit 1296, order 1
2025-09-13 16:43:35,971 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:43:35,975 - jwst.photom.photom - INFO - Working on slit 1412, order 1
2025-09-13 16:43:35,976 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:43:35,980 - jwst.photom.photom - INFO - Working on slit 654, order 1
2025-09-13 16:43:35,980 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:43:35,984 - jwst.photom.photom - INFO - Working on slit 1029, order 1
2025-09-13 16:43:35,985 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:43:35,989 - jwst.photom.photom - INFO - Working on slit 553, order 1
2025-09-13 16:43:35,990 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:43:35,994 - jwst.photom.photom - INFO - Working on slit 1387, order 1
2025-09-13 16:43:35,994 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:43:35,998 - jwst.photom.photom - INFO - Working on slit 422, order 1
2025-09-13 16:43:35,999 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:43:36,003 - jwst.photom.photom - INFO - Working on slit 821, order 1
2025-09-13 16:43:36,003 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:43:36,007 - jwst.photom.photom - INFO - Working on slit 682, order 1
2025-09-13 16:43:36,008 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:43:36,012 - jwst.photom.photom - INFO - Working on slit 1140, order 1
2025-09-13 16:43:36,012 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:43:36,016 - jwst.photom.photom - INFO - Working on slit 1388, order 1
2025-09-13 16:43:36,017 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:43:36,021 - jwst.photom.photom - INFO - Working on slit 759, order 1
2025-09-13 16:43:36,022 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:43:36,025 - jwst.photom.photom - INFO - Working on slit 1407, order 1
2025-09-13 16:43:36,026 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:43:36,030 - jwst.photom.photom - INFO - Working on slit 1194, order 1
2025-09-13 16:43:36,031 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:43:36,034 - jwst.photom.photom - INFO - Working on slit 712, order 1
2025-09-13 16:43:36,035 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:43:36,039 - jwst.photom.photom - INFO - Working on slit 539, order 1
2025-09-13 16:43:36,040 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:43:36,043 - jwst.photom.photom - INFO - Working on slit 1008, order 1
2025-09-13 16:43:36,044 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:43:36,048 - jwst.photom.photom - INFO - Working on slit 347, order 1
2025-09-13 16:43:36,049 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:43:36,052 - jwst.photom.photom - INFO - Working on slit 276, order 1
2025-09-13 16:43:36,053 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:43:36,057 - jwst.photom.photom - INFO - Working on slit 605, order 1
2025-09-13 16:43:36,058 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:43:36,061 - jwst.photom.photom - INFO - Working on slit 922, order 1
2025-09-13 16:43:36,062 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:43:36,066 - jwst.photom.photom - INFO - Working on slit 736, order 1
2025-09-13 16:43:36,067 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:43:36,070 - jwst.photom.photom - INFO - Working on slit 1423, order 1
2025-09-13 16:43:36,071 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:43:36,075 - jwst.photom.photom - INFO - Working on slit 800, order 1
2025-09-13 16:43:36,076 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:43:36,079 - jwst.photom.photom - INFO - Working on slit 873, order 1
2025-09-13 16:43:36,080 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:43:36,084 - jwst.photom.photom - INFO - Working on slit 385, order 1
2025-09-13 16:43:36,084 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:43:36,089 - jwst.photom.photom - INFO - Working on slit 557, order 1
2025-09-13 16:43:36,089 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:43:36,093 - jwst.photom.photom - INFO - Working on slit 719, order 1
2025-09-13 16:43:36,094 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:43:36,098 - jwst.photom.photom - INFO - Working on slit 389, order 1
2025-09-13 16:43:36,099 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:43:36,102 - jwst.photom.photom - INFO - Working on slit 733, order 1
2025-09-13 16:43:36,103 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:43:36,107 - jwst.photom.photom - INFO - Working on slit 1442, order 1
2025-09-13 16:43:36,108 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:43:36,111 - jwst.photom.photom - INFO - Working on slit 417, order 1
2025-09-13 16:43:36,112 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:43:36,116 - jwst.photom.photom - INFO - Working on slit 630, order 1
2025-09-13 16:43:36,117 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:43:36,120 - jwst.photom.photom - INFO - Working on slit 925, order 1
2025-09-13 16:43:36,121 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:43:36,125 - jwst.photom.photom - INFO - Working on slit 527, order 1
2025-09-13 16:43:36,126 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:43:36,130 - jwst.photom.photom - INFO - Working on slit 439, order 1
2025-09-13 16:43:36,130 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:43:36,134 - jwst.photom.photom - INFO - Working on slit 1253, order 1
2025-09-13 16:43:36,135 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:43:36,139 - jwst.photom.photom - INFO - Working on slit 1162, order 1
2025-09-13 16:43:36,139 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:43:36,143 - jwst.photom.photom - INFO - Working on slit 1457, order 1
2025-09-13 16:43:36,144 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:43:36,148 - jwst.photom.photom - INFO - Working on slit 694, order 1
2025-09-13 16:43:36,148 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:43:36,152 - jwst.photom.photom - INFO - Working on slit 1266, order 1
2025-09-13 16:43:36,153 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:43:36,157 - jwst.photom.photom - INFO - Working on slit 298, order 1
2025-09-13 16:43:36,157 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:43:36,161 - jwst.photom.photom - INFO - Working on slit 516, order 1
2025-09-13 16:43:36,162 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:43:36,166 - jwst.photom.photom - INFO - Working on slit 973, order 1
2025-09-13 16:43:36,166 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:43:36,170 - jwst.photom.photom - INFO - Working on slit 180, order 1
2025-09-13 16:43:36,171 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:43:36,175 - jwst.photom.photom - INFO - Working on slit 980, order 1
2025-09-13 16:43:36,175 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:43:36,179 - jwst.photom.photom - INFO - Working on slit 263, order 1
2025-09-13 16:43:36,180 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:43:36,184 - jwst.photom.photom - INFO - Working on slit 493, order 1
2025-09-13 16:43:36,184 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:43:36,188 - jwst.photom.photom - INFO - Working on slit 981, order 1
2025-09-13 16:43:36,189 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:43:36,192 - jwst.photom.photom - INFO - Working on slit 1371, order 1
2025-09-13 16:43:36,193 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:43:36,197 - jwst.photom.photom - INFO - Working on slit 536, order 1
2025-09-13 16:43:36,198 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:43:36,201 - jwst.photom.photom - INFO - Working on slit 749, order 1
2025-09-13 16:43:36,202 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:43:36,206 - jwst.photom.photom - INFO - Working on slit 345, order 1
2025-09-13 16:43:36,207 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:43:36,211 - jwst.photom.photom - INFO - Working on slit 721, order 1
2025-09-13 16:43:36,211 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:43:36,215 - jwst.photom.photom - INFO - Working on slit 387, order 1
2025-09-13 16:43:36,216 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:43:36,220 - jwst.photom.photom - INFO - Working on slit 505, order 1
2025-09-13 16:43:36,220 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:43:36,224 - jwst.photom.photom - INFO - Working on slit 566, order 1
2025-09-13 16:43:36,225 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:43:36,229 - jwst.photom.photom - INFO - Working on slit 772, order 1
2025-09-13 16:43:36,230 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:43:36,234 - jwst.photom.photom - INFO - Working on slit 722, order 1
2025-09-13 16:43:36,234 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:43:36,238 - jwst.photom.photom - INFO - Working on slit 872, order 1
2025-09-13 16:43:36,239 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:43:36,243 - jwst.photom.photom - INFO - Working on slit 933, order 1
2025-09-13 16:43:36,243 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:43:36,247 - jwst.photom.photom - INFO - Working on slit 1128, order 1
2025-09-13 16:43:36,248 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:43:36,251 - jwst.photom.photom - INFO - Working on slit 1282, order 1
2025-09-13 16:43:36,252 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:43:36,256 - jwst.photom.photom - INFO - Working on slit 274, order 1
2025-09-13 16:43:36,257 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:43:36,260 - jwst.photom.photom - INFO - Working on slit 641, order 1
2025-09-13 16:43:36,261 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:43:36,265 - jwst.photom.photom - INFO - Working on slit 543, order 1
2025-09-13 16:43:36,266 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:43:36,269 - jwst.photom.photom - INFO - Working on slit 610, order 1
2025-09-13 16:43:36,270 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:43:36,274 - jwst.photom.photom - INFO - Working on slit 1188, order 1
2025-09-13 16:43:36,275 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:43:36,278 - jwst.photom.photom - INFO - Working on slit 533, order 1
2025-09-13 16:43:36,279 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:43:36,283 - jwst.photom.photom - INFO - Working on slit 1342, order 1
2025-09-13 16:43:36,284 - jwst.photom.photom - INFO - PHOTMJSR value: 49.0105
2025-09-13 16:43:36,292 - stpipe.Spec2Pipeline.photom - INFO - Step photom done
2025-09-13 16:43:39,445 - stpipe.Spec2Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<MultiSlitModel from /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage2_spec/jw02079004003_05101_00003_nis_cal.fits>,).
2025-09-13 16:43:39,447 - stpipe.Spec2Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 16:43:42,499 - stpipe.Spec2Pipeline.extract_1d - INFO - Step extract_1d running with args (<MultiSlitModel from /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage2_spec/jw02079004003_05101_00003_nis_cal.fits>,).
2025-09-13 16:43:42,622 - stpipe.Spec2Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 16:43:42,672 - jwst.extract_1d.extract - INFO - Working on slit 522
2025-09-13 16:43:42,673 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:43:42,674 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 146.00 (inclusive)
2025-09-13 16:43:42,728 - jwst.extract_1d.extract - INFO - Working on slit 796
2025-09-13 16:43:42,729 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:43:42,731 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 95.00 (inclusive)
2025-09-13 16:43:42,783 - jwst.extract_1d.extract - INFO - Working on slit 1479
2025-09-13 16:43:42,784 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:43:42,786 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 56.00 (inclusive)
2025-09-13 16:43:42,838 - jwst.extract_1d.extract - INFO - Working on slit 214
2025-09-13 16:43:42,839 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:43:42,840 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 105.00 (inclusive)
2025-09-13 16:43:42,895 - jwst.extract_1d.extract - INFO - Working on slit 693
2025-09-13 16:43:42,896 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:43:42,897 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 75.00 (inclusive)
2025-09-13 16:43:42,950 - jwst.extract_1d.extract - INFO - Working on slit 1120
2025-09-13 16:43:42,951 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:43:42,952 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 68.00 (inclusive)
2025-09-13 16:43:43,004 - jwst.extract_1d.extract - INFO - Working on slit 1257
2025-09-13 16:43:43,006 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:43:43,007 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 76.00 (inclusive)
2025-09-13 16:43:43,059 - jwst.extract_1d.extract - INFO - Working on slit 766
2025-09-13 16:43:43,060 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:43:43,061 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 102.00 (inclusive)
2025-09-13 16:43:43,113 - jwst.extract_1d.extract - INFO - Working on slit 606
2025-09-13 16:43:43,115 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type POINT
2025-09-13 16:43:43,115 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 10.00 (inclusive)
2025-09-13 16:43:43,122 - jwst.extract_1d.extract - INFO - Creating aperture correction.
2025-09-13 16:43:43,265 - jwst.extract_1d.extract - INFO - Working on slit 649
2025-09-13 16:43:43,266 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:43:43,267 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 94.00 (inclusive)
2025-09-13 16:43:43,321 - jwst.extract_1d.extract - INFO - Working on slit 982
2025-09-13 16:43:43,322 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:43:43,323 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 54.00 (inclusive)
2025-09-13 16:43:43,375 - jwst.extract_1d.extract - INFO - Working on slit 1364
2025-09-13 16:43:43,376 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:43:43,377 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 59.00 (inclusive)
2025-09-13 16:43:43,429 - jwst.extract_1d.extract - INFO - Working on slit 898
2025-09-13 16:43:43,430 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type POINT
2025-09-13 16:43:43,431 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 10.00 (inclusive)
2025-09-13 16:43:43,438 - jwst.extract_1d.extract - INFO - Creating aperture correction.
2025-09-13 16:43:43,566 - jwst.extract_1d.extract - INFO - Working on slit 1049
2025-09-13 16:43:43,567 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:43:43,568 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 75.00 (inclusive)
2025-09-13 16:43:43,622 - jwst.extract_1d.extract - INFO - Working on slit 732
2025-09-13 16:43:43,623 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:43:43,624 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 43.00 (inclusive)
2025-09-13 16:43:43,676 - jwst.extract_1d.extract - INFO - Working on slit 189
2025-09-13 16:43:43,677 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:43:43,678 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 46.00 (inclusive)
2025-09-13 16:43:43,730 - jwst.extract_1d.extract - INFO - Working on slit 881
2025-09-13 16:43:43,731 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type POINT
2025-09-13 16:43:43,732 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 10.00 (inclusive)
2025-09-13 16:43:43,739 - jwst.extract_1d.extract - INFO - Creating aperture correction.
2025-09-13 16:43:43,881 - jwst.extract_1d.extract - INFO - Working on slit 966
2025-09-13 16:43:43,882 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:43:43,883 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 58.00 (inclusive)
2025-09-13 16:43:43,937 - jwst.extract_1d.extract - INFO - Working on slit 914
2025-09-13 16:43:43,938 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:43:43,939 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 31.00 (inclusive)
2025-09-13 16:43:43,991 - jwst.extract_1d.extract - INFO - Working on slit 1084
2025-09-13 16:43:43,992 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type POINT
2025-09-13 16:43:43,993 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 10.00 (inclusive)
2025-09-13 16:43:44,000 - jwst.extract_1d.extract - INFO - Creating aperture correction.
2025-09-13 16:43:44,133 - jwst.extract_1d.extract - INFO - Working on slit 540
2025-09-13 16:43:44,135 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:43:44,136 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 71.00 (inclusive)
2025-09-13 16:43:44,189 - jwst.extract_1d.extract - INFO - Working on slit 1476
2025-09-13 16:43:44,190 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:43:44,191 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 58.00 (inclusive)
2025-09-13 16:43:44,243 - jwst.extract_1d.extract - INFO - Working on slit 1142
2025-09-13 16:43:44,244 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:43:44,245 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 45.00 (inclusive)
2025-09-13 16:43:44,296 - jwst.extract_1d.extract - INFO - Working on slit 220
2025-09-13 16:43:44,297 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type POINT
2025-09-13 16:43:44,298 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 10.00 (inclusive)
2025-09-13 16:43:44,305 - jwst.extract_1d.extract - INFO - Creating aperture correction.
2025-09-13 16:43:44,434 - jwst.extract_1d.extract - INFO - Working on slit 289
2025-09-13 16:43:44,435 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:43:44,436 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 35.00 (inclusive)
2025-09-13 16:43:44,489 - jwst.extract_1d.extract - INFO - Working on slit 934
2025-09-13 16:43:44,490 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:43:44,491 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 47.00 (inclusive)
2025-09-13 16:43:44,543 - jwst.extract_1d.extract - INFO - Working on slit 1219
2025-09-13 16:43:44,544 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:43:44,545 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 60.00 (inclusive)
2025-09-13 16:43:44,598 - jwst.extract_1d.extract - INFO - Working on slit 927
2025-09-13 16:43:44,599 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:43:44,600 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 43.00 (inclusive)
2025-09-13 16:43:44,652 - jwst.extract_1d.extract - INFO - Working on slit 1417
2025-09-13 16:43:44,653 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:43:44,654 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 38.00 (inclusive)
2025-09-13 16:43:44,705 - jwst.extract_1d.extract - INFO - Working on slit 567
2025-09-13 16:43:44,706 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:43:44,707 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 48.00 (inclusive)
2025-09-13 16:43:44,762 - jwst.extract_1d.extract - INFO - Working on slit 1296
2025-09-13 16:43:44,763 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:43:44,764 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 42.00 (inclusive)
2025-09-13 16:43:44,816 - jwst.extract_1d.extract - INFO - Working on slit 1412
2025-09-13 16:43:44,817 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:43:44,818 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 38.00 (inclusive)
2025-09-13 16:43:44,869 - jwst.extract_1d.extract - INFO - Working on slit 654
2025-09-13 16:43:44,870 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:43:44,870 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 59.00 (inclusive)
2025-09-13 16:43:44,920 - jwst.extract_1d.extract - INFO - Working on slit 1029
2025-09-13 16:43:44,921 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:43:44,922 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 55.00 (inclusive)
2025-09-13 16:43:44,972 - jwst.extract_1d.extract - INFO - Working on slit 553
2025-09-13 16:43:44,973 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:43:44,973 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 35.00 (inclusive)
2025-09-13 16:43:45,023 - jwst.extract_1d.extract - INFO - Working on slit 1387
2025-09-13 16:43:45,024 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:43:45,025 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 40.00 (inclusive)
2025-09-13 16:43:45,075 - jwst.extract_1d.extract - INFO - Working on slit 422
2025-09-13 16:43:45,076 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:43:45,077 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 28.00 (inclusive)
2025-09-13 16:43:45,127 - jwst.extract_1d.extract - INFO - Working on slit 821
2025-09-13 16:43:45,128 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:43:45,129 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 42.00 (inclusive)
2025-09-13 16:43:45,179 - jwst.extract_1d.extract - INFO - Working on slit 682
2025-09-13 16:43:45,180 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:43:45,181 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 49.00 (inclusive)
2025-09-13 16:43:45,230 - jwst.extract_1d.extract - INFO - Working on slit 1140
2025-09-13 16:43:45,231 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:43:45,232 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 42.00 (inclusive)
2025-09-13 16:43:45,281 - jwst.extract_1d.extract - INFO - Working on slit 1388
2025-09-13 16:43:45,282 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:43:45,283 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 58.00 (inclusive)
2025-09-13 16:43:45,333 - jwst.extract_1d.extract - INFO - Working on slit 759
2025-09-13 16:43:45,334 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:43:45,335 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 39.00 (inclusive)
2025-09-13 16:43:45,386 - jwst.extract_1d.extract - INFO - Working on slit 1407
2025-09-13 16:43:45,386 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:43:45,387 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 35.00 (inclusive)
2025-09-13 16:43:45,437 - jwst.extract_1d.extract - INFO - Working on slit 1194
2025-09-13 16:43:45,438 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:43:45,439 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 29.00 (inclusive)
2025-09-13 16:43:45,489 - jwst.extract_1d.extract - INFO - Working on slit 712
2025-09-13 16:43:45,490 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:43:45,491 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 33.00 (inclusive)
2025-09-13 16:43:45,541 - jwst.extract_1d.extract - INFO - Working on slit 539
2025-09-13 16:43:45,542 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:43:45,543 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 42.00 (inclusive)
2025-09-13 16:43:45,593 - jwst.extract_1d.extract - INFO - Working on slit 1008
2025-09-13 16:43:45,593 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:43:45,594 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 30.00 (inclusive)
2025-09-13 16:43:45,644 - jwst.extract_1d.extract - INFO - Working on slit 347
2025-09-13 16:43:45,645 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type POINT
2025-09-13 16:43:45,646 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 10.00 (inclusive)
2025-09-13 16:43:45,653 - jwst.extract_1d.extract - INFO - Creating aperture correction.
2025-09-13 16:43:45,775 - jwst.extract_1d.extract - INFO - Working on slit 276
2025-09-13 16:43:45,776 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:43:45,777 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 44.00 (inclusive)
2025-09-13 16:43:45,828 - jwst.extract_1d.extract - INFO - Working on slit 605
2025-09-13 16:43:45,829 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type POINT
2025-09-13 16:43:45,830 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 10.00 (inclusive)
2025-09-13 16:43:45,837 - jwst.extract_1d.extract - INFO - Creating aperture correction.
2025-09-13 16:43:45,953 - jwst.extract_1d.extract - INFO - Working on slit 922
2025-09-13 16:43:45,954 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:43:45,955 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 30.00 (inclusive)
2025-09-13 16:43:46,007 - jwst.extract_1d.extract - INFO - Working on slit 736
2025-09-13 16:43:46,008 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:43:46,009 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 23.00 (inclusive)
2025-09-13 16:43:46,061 - jwst.extract_1d.extract - INFO - Working on slit 1423
2025-09-13 16:43:46,062 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:43:46,063 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 31.00 (inclusive)
2025-09-13 16:43:46,114 - jwst.extract_1d.extract - INFO - Working on slit 800
2025-09-13 16:43:46,115 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:43:46,116 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 26.00 (inclusive)
2025-09-13 16:43:46,168 - jwst.extract_1d.extract - INFO - Working on slit 873
2025-09-13 16:43:46,169 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:43:46,170 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 27.00 (inclusive)
2025-09-13 16:43:46,221 - jwst.extract_1d.extract - INFO - Working on slit 385
2025-09-13 16:43:46,222 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:43:46,223 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 21.00 (inclusive)
2025-09-13 16:43:46,275 - jwst.extract_1d.extract - INFO - Working on slit 557
2025-09-13 16:43:46,276 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:43:46,277 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 38.00 (inclusive)
2025-09-13 16:43:46,329 - jwst.extract_1d.extract - INFO - Working on slit 719
2025-09-13 16:43:46,330 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:43:46,331 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 29.00 (inclusive)
2025-09-13 16:43:46,384 - jwst.extract_1d.extract - INFO - Working on slit 389
2025-09-13 16:43:46,385 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:43:46,386 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 29.00 (inclusive)
2025-09-13 16:43:46,438 - jwst.extract_1d.extract - INFO - Working on slit 733
2025-09-13 16:43:46,439 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:43:46,440 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 43.00 (inclusive)
2025-09-13 16:43:46,492 - jwst.extract_1d.extract - INFO - Working on slit 1442
2025-09-13 16:43:46,493 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:43:46,494 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 43.00 (inclusive)
2025-09-13 16:43:46,547 - jwst.extract_1d.extract - INFO - Working on slit 417
2025-09-13 16:43:46,548 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:43:46,549 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 28.00 (inclusive)
2025-09-13 16:43:46,601 - jwst.extract_1d.extract - INFO - Working on slit 630
2025-09-13 16:43:46,602 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type POINT
2025-09-13 16:43:46,603 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 10.00 (inclusive)
2025-09-13 16:43:46,610 - jwst.extract_1d.extract - INFO - Creating aperture correction.
2025-09-13 16:43:46,727 - jwst.extract_1d.extract - INFO - Working on slit 925
2025-09-13 16:43:46,728 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:43:46,729 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 33.00 (inclusive)
2025-09-13 16:43:46,781 - jwst.extract_1d.extract - INFO - Working on slit 527
2025-09-13 16:43:46,782 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:43:46,783 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 35.00 (inclusive)
2025-09-13 16:43:46,833 - jwst.extract_1d.extract - INFO - Working on slit 439
2025-09-13 16:43:46,834 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type POINT
2025-09-13 16:43:46,835 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 10.00 (inclusive)
2025-09-13 16:43:46,842 - jwst.extract_1d.extract - INFO - Creating aperture correction.
2025-09-13 16:43:46,965 - jwst.extract_1d.extract - INFO - Working on slit 1253
2025-09-13 16:43:46,966 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:43:46,967 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 32.00 (inclusive)
2025-09-13 16:43:47,018 - jwst.extract_1d.extract - INFO - Working on slit 1162
2025-09-13 16:43:47,019 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:43:47,020 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 19.00 (inclusive)
2025-09-13 16:43:47,071 - jwst.extract_1d.extract - INFO - Working on slit 1457
2025-09-13 16:43:47,072 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:43:47,073 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 24.00 (inclusive)
2025-09-13 16:43:47,124 - jwst.extract_1d.extract - INFO - Working on slit 694
2025-09-13 16:43:47,125 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:43:47,126 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 22.00 (inclusive)
2025-09-13 16:43:47,178 - jwst.extract_1d.extract - INFO - Working on slit 1266
2025-09-13 16:43:47,179 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:43:47,180 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 27.00 (inclusive)
2025-09-13 16:43:47,231 - jwst.extract_1d.extract - INFO - Working on slit 298
2025-09-13 16:43:47,232 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:43:47,233 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 23.00 (inclusive)
2025-09-13 16:43:47,284 - jwst.extract_1d.extract - INFO - Working on slit 516
2025-09-13 16:43:47,285 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:43:47,286 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 34.00 (inclusive)
2025-09-13 16:43:47,339 - jwst.extract_1d.extract - INFO - Working on slit 973
2025-09-13 16:43:47,340 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:43:47,341 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 20.00 (inclusive)
2025-09-13 16:43:47,392 - jwst.extract_1d.extract - INFO - Working on slit 180
2025-09-13 16:43:47,393 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:43:47,394 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 32.00 (inclusive)
2025-09-13 16:43:47,446 - jwst.extract_1d.extract - INFO - Working on slit 980
2025-09-13 16:43:47,447 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:43:47,448 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 30.00 (inclusive)
2025-09-13 16:43:47,500 - jwst.extract_1d.extract - INFO - Working on slit 263
2025-09-13 16:43:47,501 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:43:47,503 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 25.00 (inclusive)
2025-09-13 16:43:47,555 - jwst.extract_1d.extract - INFO - Working on slit 493
2025-09-13 16:43:47,556 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:43:47,556 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 29.00 (inclusive)
2025-09-13 16:43:47,608 - jwst.extract_1d.extract - INFO - Working on slit 981
2025-09-13 16:43:47,610 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:43:47,610 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 22.00 (inclusive)
2025-09-13 16:43:47,663 - jwst.extract_1d.extract - INFO - Working on slit 1371
2025-09-13 16:43:47,664 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:43:47,665 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 23.00 (inclusive)
2025-09-13 16:43:47,716 - jwst.extract_1d.extract - INFO - Working on slit 536
2025-09-13 16:43:47,717 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:43:47,718 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 33.00 (inclusive)
2025-09-13 16:43:47,769 - jwst.extract_1d.extract - INFO - Working on slit 749
2025-09-13 16:43:47,770 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:43:47,771 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 22.00 (inclusive)
2025-09-13 16:43:47,823 - jwst.extract_1d.extract - INFO - Working on slit 345
2025-09-13 16:43:47,824 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:43:47,825 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 22.00 (inclusive)
2025-09-13 16:43:47,877 - jwst.extract_1d.extract - INFO - Working on slit 721
2025-09-13 16:43:47,878 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type POINT
2025-09-13 16:43:47,879 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 10.00 (inclusive)
2025-09-13 16:43:47,886 - jwst.extract_1d.extract - INFO - Creating aperture correction.
2025-09-13 16:43:48,004 - jwst.extract_1d.extract - INFO - Working on slit 387
2025-09-13 16:43:48,005 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:43:48,006 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 19.00 (inclusive)
2025-09-13 16:43:48,061 - jwst.extract_1d.extract - INFO - Working on slit 505
2025-09-13 16:43:48,062 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:43:48,063 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 21.00 (inclusive)
2025-09-13 16:43:48,115 - jwst.extract_1d.extract - INFO - Working on slit 566
2025-09-13 16:43:48,116 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:43:48,117 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 36.00 (inclusive)
2025-09-13 16:43:48,170 - jwst.extract_1d.extract - INFO - Working on slit 772
2025-09-13 16:43:48,171 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:43:48,172 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 25.00 (inclusive)
2025-09-13 16:43:48,225 - jwst.extract_1d.extract - INFO - Working on slit 722
2025-09-13 16:43:48,226 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:43:48,227 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 26.00 (inclusive)
2025-09-13 16:43:48,278 - jwst.extract_1d.extract - INFO - Working on slit 872
2025-09-13 16:43:48,280 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type POINT
2025-09-13 16:43:48,280 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 10.00 (inclusive)
2025-09-13 16:43:48,287 - jwst.extract_1d.extract - INFO - Creating aperture correction.
2025-09-13 16:43:48,407 - jwst.extract_1d.extract - INFO - Working on slit 933
2025-09-13 16:43:48,408 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:43:48,409 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 25.00 (inclusive)
2025-09-13 16:43:48,462 - jwst.extract_1d.extract - INFO - Working on slit 1128
2025-09-13 16:43:48,463 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type POINT
2025-09-13 16:43:48,464 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 10.00 (inclusive)
2025-09-13 16:43:48,471 - jwst.extract_1d.extract - INFO - Creating aperture correction.
2025-09-13 16:43:48,585 - jwst.extract_1d.extract - INFO - Working on slit 1282
2025-09-13 16:43:48,586 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:43:48,587 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 34.00 (inclusive)
2025-09-13 16:43:48,640 - jwst.extract_1d.extract - INFO - Working on slit 274
2025-09-13 16:43:48,641 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:43:48,642 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 32.00 (inclusive)
2025-09-13 16:43:48,695 - jwst.extract_1d.extract - INFO - Working on slit 641
2025-09-13 16:43:48,696 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:43:48,697 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 22.00 (inclusive)
2025-09-13 16:43:48,749 - jwst.extract_1d.extract - INFO - Working on slit 543
2025-09-13 16:43:48,751 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:43:48,752 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 28.00 (inclusive)
2025-09-13 16:43:48,803 - jwst.extract_1d.extract - INFO - Working on slit 610
2025-09-13 16:43:48,804 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type POINT
2025-09-13 16:43:48,805 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 10.00 (inclusive)
2025-09-13 16:43:48,811 - jwst.extract_1d.extract - INFO - Creating aperture correction.
2025-09-13 16:43:48,867 - jwst.extract_1d.extract - INFO - Working on slit 1188
2025-09-13 16:43:48,868 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:43:48,869 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 37.00 (inclusive)
2025-09-13 16:43:48,921 - jwst.extract_1d.extract - INFO - Working on slit 533
2025-09-13 16:43:48,922 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:43:48,923 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 21.00 (inclusive)
2025-09-13 16:43:48,974 - jwst.extract_1d.extract - INFO - Working on slit 1342
2025-09-13 16:43:48,975 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:43:48,976 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 22.00 (inclusive)
2025-09-13 16:43:49,294 - stpipe.Spec2Pipeline.extract_1d - INFO - Saved model in /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage2_spec/jw02079004003_05101_00003_nis_x1d.fits
2025-09-13 16:43:49,295 - stpipe.Spec2Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 16:43:49,298 - stpipe.Spec2Pipeline - INFO - Finished processing product /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage1/jw02079004003_05101_00003_nis
2025-09-13 16:43:49,301 - stpipe.Spec2Pipeline - INFO - Ending calwebb_spec2
2025-09-13 16:43:49,302 - jwst.stpipe.core - INFO - Results used CRDS context: jwst_1413.pmap
2025-09-13 16:44:00,747 - stpipe.Spec2Pipeline - INFO - Saved model in /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage2_spec/jw02079004003_05101_00003_nis_cal.fits
2025-09-13 16:44:00,748 - stpipe.Spec2Pipeline - INFO - Step Spec2Pipeline done
2025-09-13 16:44:00,749 - jwst.stpipe.core - INFO - Results used jwst version: 1.19.1
2025-09-13 16:44:00,762 - py.warnings - WARNING - /usr/share/miniconda/lib/python3.13/site-packages/jwst/associations/association.py:234: UserWarning: Input association file contains path information; note that this can complicate usage and/or sharing of such files.
warnings.warn(err_str, UserWarning, stacklevel=1)
2025-09-13 16:44:00,821 - stpipe - INFO - PARS-SPEC2PIPELINE parameters found: /home/runner/crds/references/jwst/niriss/jwst_niriss_pars-spec2pipeline_0005.asdf
2025-09-13 16:44:00,843 - stpipe.Spec2Pipeline - INFO - Spec2Pipeline instance created.
2025-09-13 16:44:00,844 - stpipe.Spec2Pipeline.assign_wcs - INFO - AssignWcsStep instance created.
2025-09-13 16:44:00,845 - stpipe.Spec2Pipeline.badpix_selfcal - INFO - BadpixSelfcalStep instance created.
2025-09-13 16:44:00,846 - stpipe.Spec2Pipeline.msa_flagging - INFO - MSAFlagOpenStep instance created.
2025-09-13 16:44:00,847 - stpipe.Spec2Pipeline.nsclean - INFO - NSCleanStep instance created.
2025-09-13 16:44:00,848 - stpipe.Spec2Pipeline.bkg_subtract - INFO - BackgroundStep instance created.
2025-09-13 16:44:00,849 - stpipe.Spec2Pipeline.imprint_subtract - INFO - ImprintStep instance created.
2025-09-13 16:44:00,850 - stpipe.Spec2Pipeline.extract_2d - INFO - Extract2dStep instance created.
2025-09-13 16:44:00,855 - stpipe.Spec2Pipeline.master_background_mos - INFO - MasterBackgroundMosStep instance created.
2025-09-13 16:44:00,856 - stpipe.Spec2Pipeline.master_background_mos.flat_field - INFO - FlatFieldStep instance created.
2025-09-13 16:44:00,857 - stpipe.Spec2Pipeline.master_background_mos.pathloss - INFO - PathLossStep instance created.
2025-09-13 16:44:00,857 - stpipe.Spec2Pipeline.master_background_mos.barshadow - INFO - BarShadowStep instance created.
2025-09-13 16:44:00,858 - stpipe.Spec2Pipeline.master_background_mos.photom - INFO - PhotomStep instance created.
2025-09-13 16:44:00,859 - stpipe.Spec2Pipeline.master_background_mos.pixel_replace - INFO - PixelReplaceStep instance created.
2025-09-13 16:44:00,860 - stpipe.Spec2Pipeline.master_background_mos.resample_spec - INFO - ResampleSpecStep instance created.
2025-09-13 16:44:00,862 - stpipe.Spec2Pipeline.master_background_mos.extract_1d - INFO - Extract1dStep instance created.
2025-09-13 16:44:00,862 - stpipe.Spec2Pipeline.wavecorr - INFO - WavecorrStep instance created.
2025-09-13 16:44:00,863 - stpipe.Spec2Pipeline.flat_field - INFO - FlatFieldStep instance created.
2025-09-13 16:44:00,864 - stpipe.Spec2Pipeline.srctype - INFO - SourceTypeStep instance created.
2025-09-13 16:44:00,865 - stpipe.Spec2Pipeline.straylight - INFO - StraylightStep instance created.
2025-09-13 16:44:00,866 - stpipe.Spec2Pipeline.fringe - INFO - FringeStep instance created.
2025-09-13 16:44:00,867 - stpipe.Spec2Pipeline.residual_fringe - INFO - ResidualFringeStep instance created.
2025-09-13 16:44:00,869 - stpipe.Spec2Pipeline.pathloss - INFO - PathLossStep instance created.
2025-09-13 16:44:00,870 - stpipe.Spec2Pipeline.barshadow - INFO - BarShadowStep instance created.
2025-09-13 16:44:00,870 - stpipe.Spec2Pipeline.wfss_contam - INFO - WfssContamStep instance created.
2025-09-13 16:44:00,872 - stpipe.Spec2Pipeline.photom - INFO - PhotomStep instance created.
2025-09-13 16:44:00,873 - stpipe.Spec2Pipeline.pixel_replace - INFO - PixelReplaceStep instance created.
2025-09-13 16:44:00,874 - stpipe.Spec2Pipeline.resample_spec - INFO - ResampleSpecStep instance created.
2025-09-13 16:44:00,875 - stpipe.Spec2Pipeline.cube_build - INFO - CubeBuildStep instance created.
2025-09-13 16:44:00,877 - stpipe.Spec2Pipeline.extract_1d - INFO - Extract1dStep instance created.
2025-09-13 16:44:01,582 - stpipe.Spec2Pipeline - INFO - Step Spec2Pipeline running with args ('/home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/jw02079004003_03101_00001_nis_spec2_asn.json',).
2025-09-13 16:44:01,617 - stpipe.Spec2Pipeline - INFO - Step Spec2Pipeline parameters are:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage2_spec
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: True
skip: False
suffix: None
search_output_file: True
input_dir: ''
save_bsub: False
fail_on_exception: True
save_wfss_esec: False
steps:
assign_wcs:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
sip_approx: True
sip_max_pix_error: 0.01
sip_degree: None
sip_max_inv_pix_error: 0.01
sip_inv_degree: None
sip_npoints: 12
slit_y_low: -0.55
slit_y_high: 0.55
nrs_ifu_slice_wcs: False
badpix_selfcal:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: True
suffix: None
search_output_file: True
input_dir: ''
flagfrac_lower: 0.001
flagfrac_upper: 0.001
kernel_size: 15
force_single: False
save_flagged_bkg: False
msa_flagging:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
nsclean:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: True
suffix: None
search_output_file: True
input_dir: ''
fit_method: fft
fit_by_channel: False
background_method: None
background_box_size: None
mask_spectral_regions: True
n_sigma: 5.0
fit_histogram: False
single_mask: False
user_mask: None
save_mask: False
save_background: False
save_noise: False
bkg_subtract:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
bkg_list: None
save_combined_background: False
sigma: 3.0
maxiters: None
soss_source_percentile: 35.0
soss_bkg_percentile: None
wfss_mmag_extract: None
wfss_maxiter: 5
wfss_rms_stop: 0.0
wfss_outlier_percent: 1.0
imprint_subtract:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
extract_2d:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
slit_names: None
source_ids: None
extract_orders: None
grism_objects: None
tsgrism_extract_height: None
wfss_extract_half_height: 5
wfss_mmag_extract: None
wfss_nbright: 100
master_background_mos:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: True
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
sigma_clip: 3.0
median_kernel: 1
force_subtract: False
save_background: False
user_background: None
inverse: False
steps:
flat_field:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
save_interpolated_flat: False
user_supplied_flat: None
inverse: False
pathloss:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
inverse: False
source_type: None
user_slit_loc: None
barshadow:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
inverse: False
source_type: None
photom:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
inverse: False
source_type: None
mrs_time_correction: True
pixel_replace:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: True
output_use_index: True
save_results: False
skip: True
suffix: None
search_output_file: True
input_dir: ''
algorithm: fit_profile
n_adjacent_cols: 3
resample_spec:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
pixfrac: 1.0
kernel: square
fillval: NAN
weight_type: ivm
output_shape: None
pixel_scale_ratio: 1.0
pixel_scale: None
output_wcs: ''
single: False
blendheaders: True
in_memory: True
extract_1d:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
subtract_background: None
apply_apcorr: True
extraction_type: box
use_source_posn: None
position_offset: 0.0
model_nod_pair: True
optimize_psf_location: True
smoothing_length: None
bkg_fit: None
bkg_order: None
log_increment: 50
save_profile: False
save_scene_model: False
save_residual_image: False
center_xy: None
ifu_autocen: False
bkg_sigma_clip: 3.0
ifu_rfcorr: True
ifu_set_srctype: None
ifu_rscale: None
ifu_covar_scale: 1.0
soss_atoca: True
soss_threshold: 0.01
soss_n_os: 2
soss_wave_grid_in: None
soss_wave_grid_out: None
soss_estimate: None
soss_rtol: 0.0001
soss_max_grid_size: 20000
soss_tikfac: None
soss_width: 40.0
soss_bad_pix: masking
soss_modelname: None
wavecorr:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
flat_field:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
save_interpolated_flat: False
user_supplied_flat: None
inverse: False
srctype:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
source_type: None
straylight:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
clean_showers: False
shower_plane: 3
shower_x_stddev: 18.0
shower_y_stddev: 5.0
shower_low_reject: 0.1
shower_high_reject: 99.9
save_shower_model: False
fringe:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
residual_fringe:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: True
suffix: residual_fringe
search_output_file: False
input_dir: ''
save_intermediate_results: False
ignore_region_min: None
ignore_region_max: None
pathloss:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
inverse: False
source_type: None
user_slit_loc: None
barshadow:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
inverse: False
source_type: None
wfss_contam:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: True
suffix: None
search_output_file: True
input_dir: ''
save_simulated_image: False
save_contam_images: False
maximum_cores: none
photom:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
inverse: False
source_type: None
mrs_time_correction: True
pixel_replace:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: True
output_use_index: True
save_results: False
skip: True
suffix: None
search_output_file: True
input_dir: ''
algorithm: fit_profile
n_adjacent_cols: 3
resample_spec:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
pixfrac: 1.0
kernel: square
fillval: NAN
weight_type: ivm
output_shape: None
pixel_scale_ratio: 1.0
pixel_scale: None
output_wcs: ''
single: False
blendheaders: True
in_memory: True
cube_build:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: True
output_use_index: True
save_results: False
skip: False
suffix: s3d
search_output_file: False
input_dir: ''
channel: all
band: all
grating: all
filter: all
output_type: None
scalexy: 0.0
scalew: 0.0
weighting: drizzle
coord_system: skyalign
ra_center: None
dec_center: None
cube_pa: None
nspax_x: None
nspax_y: None
rois: 0.0
roiw: 0.0
weight_power: 2.0
wavemin: None
wavemax: None
single: False
skip_dqflagging: False
offset_file: None
debug_spaxel: -1 -1 -1
extract_1d:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
subtract_background: None
apply_apcorr: True
extraction_type: box
use_source_posn: None
position_offset: 0.0
model_nod_pair: True
optimize_psf_location: True
smoothing_length: None
bkg_fit: None
bkg_order: None
log_increment: 50
save_profile: False
save_scene_model: False
save_residual_image: False
center_xy: None
ifu_autocen: False
bkg_sigma_clip: 3.0
ifu_rfcorr: True
ifu_set_srctype: None
ifu_rscale: None
ifu_covar_scale: 1.0
soss_atoca: True
soss_threshold: 0.01
soss_n_os: 2
soss_wave_grid_in: None
soss_wave_grid_out: None
soss_estimate: None
soss_rtol: 0.0001
soss_max_grid_size: 20000
soss_tikfac: None
soss_width: 40.0
soss_bad_pix: masking
soss_modelname: None
2025-09-13 16:44:01,670 - stpipe.Spec2Pipeline - INFO - Prefetching reference files for dataset: 'jw02079004003_03101_00001_nis_spec2_asn.json' reftypes = ['apcorr', 'area', 'barshadow', 'bkg', 'camera', 'collimator', 'cubepar', 'dflat', 'disperser', 'distortion', 'extract1d', 'fflat', 'filteroffset', 'flat', 'fore', 'fpa', 'fringe', 'ifufore', 'ifupost', 'ifuslicer', 'mrsxartcorr', 'msa', 'msaoper', 'ote', 'pastasoss', 'pathloss', 'photom', 'psf', 'regions', 'sflat', 'speckernel', 'specprofile', 'specwcs', 'wavecorr', 'wavelengthrange']
2025-09-13 16:44:01,673 - stpipe.Spec2Pipeline - INFO - Prefetch for APCORR reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits'.
2025-09-13 16:44:01,674 - stpipe.Spec2Pipeline - INFO - Prefetch for AREA reference file is 'N/A'.
2025-09-13 16:44:01,674 - stpipe.Spec2Pipeline - INFO - Prefetch for BARSHADOW reference file is 'N/A'.
2025-09-13 16:44:01,675 - stpipe.Spec2Pipeline - INFO - Prefetch for BKG reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_bkg_0029.fits'.
2025-09-13 16:44:01,675 - stpipe.Spec2Pipeline - INFO - Prefetch for CAMERA reference file is 'N/A'.
2025-09-13 16:44:01,676 - stpipe.Spec2Pipeline - INFO - Prefetch for COLLIMATOR reference file is 'N/A'.
2025-09-13 16:44:01,676 - stpipe.Spec2Pipeline - INFO - Prefetch for CUBEPAR reference file is 'N/A'.
2025-09-13 16:44:01,676 - stpipe.Spec2Pipeline - INFO - Prefetch for DFLAT reference file is 'N/A'.
2025-09-13 16:44:01,677 - stpipe.Spec2Pipeline - INFO - Prefetch for DISPERSER reference file is 'N/A'.
2025-09-13 16:44:01,677 - stpipe.Spec2Pipeline - INFO - Prefetch for DISTORTION reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_distortion_0037.asdf'.
2025-09-13 16:44:01,678 - stpipe.Spec2Pipeline - INFO - Prefetch for EXTRACT1D reference file is 'N/A'.
2025-09-13 16:44:01,679 - stpipe.Spec2Pipeline - INFO - Prefetch for FFLAT reference file is 'N/A'.
2025-09-13 16:44:01,679 - stpipe.Spec2Pipeline - INFO - Prefetch for FILTEROFFSET reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_filteroffset_0006.asdf'.
2025-09-13 16:44:01,680 - stpipe.Spec2Pipeline - INFO - Prefetch for FLAT reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_flat_0271.fits'.
2025-09-13 16:44:01,680 - stpipe.Spec2Pipeline - INFO - Prefetch for FORE reference file is 'N/A'.
2025-09-13 16:44:01,681 - stpipe.Spec2Pipeline - INFO - Prefetch for FPA reference file is 'N/A'.
2025-09-13 16:44:01,681 - stpipe.Spec2Pipeline - INFO - Prefetch for FRINGE reference file is 'N/A'.
2025-09-13 16:44:01,682 - stpipe.Spec2Pipeline - INFO - Prefetch for IFUFORE reference file is 'N/A'.
2025-09-13 16:44:01,682 - stpipe.Spec2Pipeline - INFO - Prefetch for IFUPOST reference file is 'N/A'.
2025-09-13 16:44:01,683 - stpipe.Spec2Pipeline - INFO - Prefetch for IFUSLICER reference file is 'N/A'.
2025-09-13 16:44:01,683 - stpipe.Spec2Pipeline - INFO - Prefetch for MRSXARTCORR reference file is 'N/A'.
2025-09-13 16:44:01,683 - stpipe.Spec2Pipeline - INFO - Prefetch for MSA reference file is 'N/A'.
2025-09-13 16:44:01,684 - stpipe.Spec2Pipeline - INFO - Prefetch for MSAOPER reference file is 'N/A'.
2025-09-13 16:44:01,685 - stpipe.Spec2Pipeline - INFO - Prefetch for OTE reference file is 'N/A'.
2025-09-13 16:44:01,685 - stpipe.Spec2Pipeline - INFO - Prefetch for PASTASOSS reference file is 'N/A'.
2025-09-13 16:44:01,686 - stpipe.Spec2Pipeline - INFO - Prefetch for PATHLOSS reference file is 'N/A'.
2025-09-13 16:44:01,686 - stpipe.Spec2Pipeline - INFO - Prefetch for PHOTOM reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_photom_0041.fits'.
2025-09-13 16:44:01,687 - stpipe.Spec2Pipeline - INFO - Prefetch for PSF reference file is 'N/A'.
2025-09-13 16:44:01,687 - stpipe.Spec2Pipeline - INFO - Prefetch for REGIONS reference file is 'N/A'.
2025-09-13 16:44:01,688 - stpipe.Spec2Pipeline - INFO - Prefetch for SFLAT reference file is 'N/A'.
2025-09-13 16:44:01,688 - stpipe.Spec2Pipeline - INFO - Prefetch for SPECKERNEL reference file is 'N/A'.
2025-09-13 16:44:01,688 - stpipe.Spec2Pipeline - INFO - Prefetch for SPECPROFILE reference file is 'N/A'.
2025-09-13 16:44:01,689 - stpipe.Spec2Pipeline - INFO - Prefetch for SPECWCS reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_specwcs_0065.asdf'.
2025-09-13 16:44:01,690 - stpipe.Spec2Pipeline - INFO - Prefetch for WAVECORR reference file is 'N/A'.
2025-09-13 16:44:01,690 - stpipe.Spec2Pipeline - INFO - Prefetch for WAVELENGTHRANGE reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_wavelengthrange_0002.asdf'.
2025-09-13 16:44:01,691 - stpipe.Spec2Pipeline - INFO - Starting calwebb_spec2 ...
2025-09-13 16:44:01,697 - stpipe.Spec2Pipeline - INFO - Processing product /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage1/jw02079004003_03101_00001_nis
2025-09-13 16:44:01,698 - stpipe.Spec2Pipeline - INFO - Working on input /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage1/jw02079004003_03101_00001_nis_rate.fits ...
2025-09-13 16:44:01,747 - stpipe.Spec2Pipeline - INFO - Using sourcecat file jw02079-o004_niriss_clear-f200w_cat.ecsv
2025-09-13 16:44:01,748 - stpipe.Spec2Pipeline - INFO - Using segmentation map jw02079-o004_niriss_clear-f200w_segm.fits
2025-09-13 16:44:01,749 - stpipe.Spec2Pipeline - INFO - Using direct image jw02079-o004_niriss_clear-f200w_i2d.fits
2025-09-13 16:44:02,148 - stpipe.Spec2Pipeline.assign_wcs - INFO - Step assign_wcs running with args (<ImageModel(2048, 2048) from jw02079004003_03101_00001_nis_rate.fits>,).
2025-09-13 16:44:02,263 - jwst.assign_wcs.niriss - INFO - Added Barycentric velocity correction: 0.9999282763888806
2025-09-13 16:44:02,321 - jwst.assign_wcs.niriss - INFO - Offsets from filteroffset file are 2.119, -1.0476
2025-09-13 16:44:02,399 - jwst.assign_wcs.assign_wcs - INFO - COMPLETED assign_wcs
2025-09-13 16:44:02,400 - stpipe.AssignWcsStep - INFO - AssignWcsStep instance created.
2025-09-13 16:44:02,478 - jwst.assign_wcs.niriss - INFO - Offsets from filteroffset file are 2.119, -1.0476
2025-09-13 16:44:02,528 - stpipe.Spec2Pipeline.assign_wcs - INFO - Step assign_wcs done
2025-09-13 16:44:02,939 - stpipe.Spec2Pipeline.badpix_selfcal - INFO - Step badpix_selfcal running with args (<ImageModel(2048, 2048) from jw02079004003_03101_00001_nis_rate.fits>, [], []).
2025-09-13 16:44:02,940 - stpipe.Spec2Pipeline.badpix_selfcal - INFO - Step skipped.
2025-09-13 16:44:03,352 - stpipe.Spec2Pipeline.msa_flagging - INFO - Step msa_flagging running with args (<ImageModel(2048, 2048) from jw02079004003_03101_00001_nis_rate.fits>,).
2025-09-13 16:44:03,352 - stpipe.Spec2Pipeline.msa_flagging - INFO - Step skipped.
2025-09-13 16:44:03,767 - stpipe.Spec2Pipeline.nsclean - INFO - Step nsclean running with args (<ImageModel(2048, 2048) from jw02079004003_03101_00001_nis_rate.fits>,).
2025-09-13 16:44:03,768 - stpipe.Spec2Pipeline.nsclean - INFO - Step skipped.
2025-09-13 16:44:04,174 - stpipe.Spec2Pipeline.imprint_subtract - INFO - Step imprint_subtract running with args (<ImageModel(2048, 2048) from jw02079004003_03101_00001_nis_rate.fits>, []).
2025-09-13 16:44:04,175 - stpipe.Spec2Pipeline.imprint_subtract - INFO - Step skipped.
2025-09-13 16:44:04,575 - stpipe.Spec2Pipeline.bkg_subtract - INFO - Step bkg_subtract running with args (<ImageModel(2048, 2048) from jw02079004003_03101_00001_nis_rate.fits>, []).
2025-09-13 16:44:04,833 - jwst.background.asn_intake - INFO - Working on input <ImageModel(2048, 2048) from jw02079004003_03101_00001_nis_rate.fits> ...
2025-09-13 16:44:05,143 - stpipe.Spec2Pipeline.bkg_subtract - INFO - Using BKG reference file /home/runner/crds/references/jwst/niriss/jwst_niriss_bkg_0029.fits
2025-09-13 16:44:05,143 - stpipe.Spec2Pipeline.bkg_subtract - INFO - Using WavelengthRange reference file /home/runner/crds/references/jwst/niriss/jwst_niriss_wavelengthrange_0002.asdf
2025-09-13 16:44:05,208 - jwst.assign_wcs.util - INFO - Getting objects from jw02079-o004_niriss_clear-f200w_cat.ecsv
2025-09-13 16:44:05,506 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1, order 1
2025-09-13 16:44:05,518 - jwst.assign_wcs.util - INFO - Excluding off-image object: 2, order 1
2025-09-13 16:44:05,530 - jwst.assign_wcs.util - INFO - Excluding off-image object: 3, order 1
2025-09-13 16:44:05,542 - jwst.assign_wcs.util - INFO - Excluding off-image object: 4, order 1
2025-09-13 16:44:05,554 - jwst.assign_wcs.util - INFO - Excluding off-image object: 5, order 1
2025-09-13 16:44:05,567 - jwst.assign_wcs.util - INFO - Excluding off-image object: 6, order 1
2025-09-13 16:44:05,579 - jwst.assign_wcs.util - INFO - Excluding off-image object: 7, order 1
2025-09-13 16:44:05,591 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 8 order: 1
2025-09-13 16:44:05,603 - jwst.assign_wcs.util - INFO - Excluding off-image object: 9, order 1
2025-09-13 16:44:05,615 - jwst.assign_wcs.util - INFO - Excluding off-image object: 10, order 1
2025-09-13 16:44:05,627 - jwst.assign_wcs.util - INFO - Excluding off-image object: 11, order 1
2025-09-13 16:44:05,640 - jwst.assign_wcs.util - INFO - Excluding off-image object: 12, order 1
2025-09-13 16:44:05,652 - jwst.assign_wcs.util - INFO - Excluding off-image object: 13, order 1
2025-09-13 16:44:05,664 - jwst.assign_wcs.util - INFO - Excluding off-image object: 14, order 1
2025-09-13 16:44:05,676 - jwst.assign_wcs.util - INFO - Excluding off-image object: 15, order 1
2025-09-13 16:44:05,689 - jwst.assign_wcs.util - INFO - Excluding off-image object: 16, order 1
2025-09-13 16:44:05,701 - jwst.assign_wcs.util - INFO - Excluding off-image object: 17, order 1
2025-09-13 16:44:05,713 - jwst.assign_wcs.util - INFO - Excluding off-image object: 18, order 1
2025-09-13 16:44:05,725 - jwst.assign_wcs.util - INFO - Excluding off-image object: 19, order 1
2025-09-13 16:44:05,737 - jwst.assign_wcs.util - INFO - Excluding off-image object: 20, order 1
2025-09-13 16:44:05,749 - jwst.assign_wcs.util - INFO - Excluding off-image object: 21, order 1
2025-09-13 16:44:05,761 - jwst.assign_wcs.util - INFO - Excluding off-image object: 22, order 1
2025-09-13 16:44:05,773 - jwst.assign_wcs.util - INFO - Excluding off-image object: 23, order 1
2025-09-13 16:44:05,785 - jwst.assign_wcs.util - INFO - Excluding off-image object: 24, order 1
2025-09-13 16:44:05,797 - jwst.assign_wcs.util - INFO - Excluding off-image object: 25, order 1
2025-09-13 16:44:05,809 - jwst.assign_wcs.util - INFO - Excluding off-image object: 26, order 1
2025-09-13 16:44:05,821 - jwst.assign_wcs.util - INFO - Excluding off-image object: 27, order 1
2025-09-13 16:44:05,833 - jwst.assign_wcs.util - INFO - Excluding off-image object: 28, order 1
2025-09-13 16:44:05,845 - jwst.assign_wcs.util - INFO - Excluding off-image object: 29, order 1
2025-09-13 16:44:05,858 - jwst.assign_wcs.util - INFO - Excluding off-image object: 30, order 1
2025-09-13 16:44:05,870 - jwst.assign_wcs.util - INFO - Excluding off-image object: 31, order 1
2025-09-13 16:44:05,883 - jwst.assign_wcs.util - INFO - Excluding off-image object: 32, order 1
2025-09-13 16:44:05,895 - jwst.assign_wcs.util - INFO - Excluding off-image object: 33, order 1
2025-09-13 16:44:05,907 - jwst.assign_wcs.util - INFO - Excluding off-image object: 34, order 1
2025-09-13 16:44:05,919 - jwst.assign_wcs.util - INFO - Excluding off-image object: 35, order 1
2025-09-13 16:44:05,931 - jwst.assign_wcs.util - INFO - Excluding off-image object: 36, order 1
2025-09-13 16:44:05,944 - jwst.assign_wcs.util - INFO - Excluding off-image object: 37, order 1
2025-09-13 16:44:05,956 - jwst.assign_wcs.util - INFO - Excluding off-image object: 38, order 1
2025-09-13 16:44:05,968 - jwst.assign_wcs.util - INFO - Excluding off-image object: 39, order 1
2025-09-13 16:44:05,980 - jwst.assign_wcs.util - INFO - Excluding off-image object: 40, order 1
2025-09-13 16:44:05,992 - jwst.assign_wcs.util - INFO - Excluding off-image object: 41, order 1
2025-09-13 16:44:06,004 - jwst.assign_wcs.util - INFO - Excluding off-image object: 42, order 1
2025-09-13 16:44:06,016 - jwst.assign_wcs.util - INFO - Excluding off-image object: 43, order 1
2025-09-13 16:44:06,028 - jwst.assign_wcs.util - INFO - Excluding off-image object: 44, order 1
2025-09-13 16:44:06,040 - jwst.assign_wcs.util - INFO - Excluding off-image object: 45, order 1
2025-09-13 16:44:06,052 - jwst.assign_wcs.util - INFO - Excluding off-image object: 46, order 1
2025-09-13 16:44:06,064 - jwst.assign_wcs.util - INFO - Excluding off-image object: 47, order 1
2025-09-13 16:44:06,077 - jwst.assign_wcs.util - INFO - Excluding off-image object: 48, order 1
2025-09-13 16:44:06,089 - jwst.assign_wcs.util - INFO - Excluding off-image object: 49, order 1
2025-09-13 16:44:06,101 - jwst.assign_wcs.util - INFO - Excluding off-image object: 50, order 1
2025-09-13 16:44:06,114 - jwst.assign_wcs.util - INFO - Excluding off-image object: 51, order 1
2025-09-13 16:44:06,126 - jwst.assign_wcs.util - INFO - Excluding off-image object: 52, order 1
2025-09-13 16:44:06,138 - jwst.assign_wcs.util - INFO - Excluding off-image object: 53, order 1
2025-09-13 16:44:06,150 - jwst.assign_wcs.util - INFO - Excluding off-image object: 54, order 1
2025-09-13 16:44:06,162 - jwst.assign_wcs.util - INFO - Excluding off-image object: 55, order 1
2025-09-13 16:44:06,174 - jwst.assign_wcs.util - INFO - Excluding off-image object: 56, order 1
2025-09-13 16:44:06,187 - jwst.assign_wcs.util - INFO - Excluding off-image object: 57, order 1
2025-09-13 16:44:06,199 - jwst.assign_wcs.util - INFO - Excluding off-image object: 58, order 1
2025-09-13 16:44:06,211 - jwst.assign_wcs.util - INFO - Excluding off-image object: 59, order 1
2025-09-13 16:44:06,223 - jwst.assign_wcs.util - INFO - Excluding off-image object: 60, order 1
2025-09-13 16:44:06,235 - jwst.assign_wcs.util - INFO - Excluding off-image object: 61, order 1
2025-09-13 16:44:06,248 - jwst.assign_wcs.util - INFO - Excluding off-image object: 62, order 1
2025-09-13 16:44:06,260 - jwst.assign_wcs.util - INFO - Excluding off-image object: 63, order 1
2025-09-13 16:44:06,272 - jwst.assign_wcs.util - INFO - Excluding off-image object: 64, order 1
2025-09-13 16:44:06,284 - jwst.assign_wcs.util - INFO - Excluding off-image object: 65, order 1
2025-09-13 16:44:06,297 - jwst.assign_wcs.util - INFO - Excluding off-image object: 66, order 1
2025-09-13 16:44:06,309 - jwst.assign_wcs.util - INFO - Excluding off-image object: 67, order 1
2025-09-13 16:44:06,322 - jwst.assign_wcs.util - INFO - Excluding off-image object: 68, order 1
2025-09-13 16:44:06,334 - jwst.assign_wcs.util - INFO - Excluding off-image object: 69, order 1
2025-09-13 16:44:06,346 - jwst.assign_wcs.util - INFO - Excluding off-image object: 70, order 1
2025-09-13 16:44:06,358 - jwst.assign_wcs.util - INFO - Excluding off-image object: 71, order 1
2025-09-13 16:44:06,370 - jwst.assign_wcs.util - INFO - Excluding off-image object: 72, order 1
2025-09-13 16:44:06,382 - jwst.assign_wcs.util - INFO - Excluding off-image object: 73, order 1
2025-09-13 16:44:06,394 - jwst.assign_wcs.util - INFO - Excluding off-image object: 74, order 1
2025-09-13 16:44:06,407 - jwst.assign_wcs.util - INFO - Excluding off-image object: 75, order 1
2025-09-13 16:44:06,419 - jwst.assign_wcs.util - INFO - Excluding off-image object: 76, order 1
2025-09-13 16:44:06,431 - jwst.assign_wcs.util - INFO - Excluding off-image object: 77, order 1
2025-09-13 16:44:06,443 - jwst.assign_wcs.util - INFO - Excluding off-image object: 78, order 1
2025-09-13 16:44:06,456 - jwst.assign_wcs.util - INFO - Excluding off-image object: 79, order 1
2025-09-13 16:44:06,468 - jwst.assign_wcs.util - INFO - Excluding off-image object: 80, order 1
2025-09-13 16:44:06,480 - jwst.assign_wcs.util - INFO - Excluding off-image object: 81, order 1
2025-09-13 16:44:06,492 - jwst.assign_wcs.util - INFO - Excluding off-image object: 82, order 1
2025-09-13 16:44:06,505 - jwst.assign_wcs.util - INFO - Excluding off-image object: 83, order 1
2025-09-13 16:44:06,517 - jwst.assign_wcs.util - INFO - Excluding off-image object: 84, order 1
2025-09-13 16:44:06,532 - jwst.assign_wcs.util - INFO - Excluding off-image object: 85, order 1
2025-09-13 16:44:06,544 - jwst.assign_wcs.util - INFO - Excluding off-image object: 86, order 1
2025-09-13 16:44:06,557 - jwst.assign_wcs.util - INFO - Excluding off-image object: 87, order 1
2025-09-13 16:44:06,569 - jwst.assign_wcs.util - INFO - Excluding off-image object: 88, order 1
2025-09-13 16:44:06,581 - jwst.assign_wcs.util - INFO - Excluding off-image object: 89, order 1
2025-09-13 16:44:06,593 - jwst.assign_wcs.util - INFO - Excluding off-image object: 90, order 1
2025-09-13 16:44:06,605 - jwst.assign_wcs.util - INFO - Excluding off-image object: 91, order 1
2025-09-13 16:44:06,617 - jwst.assign_wcs.util - INFO - Excluding off-image object: 92, order 1
2025-09-13 16:44:06,629 - jwst.assign_wcs.util - INFO - Excluding off-image object: 93, order 1
2025-09-13 16:44:06,641 - jwst.assign_wcs.util - INFO - Excluding off-image object: 94, order 1
2025-09-13 16:44:06,654 - jwst.assign_wcs.util - INFO - Excluding off-image object: 95, order 1
2025-09-13 16:44:06,666 - jwst.assign_wcs.util - INFO - Excluding off-image object: 96, order 1
2025-09-13 16:44:06,678 - jwst.assign_wcs.util - INFO - Excluding off-image object: 97, order 1
2025-09-13 16:44:06,690 - jwst.assign_wcs.util - INFO - Excluding off-image object: 98, order 1
2025-09-13 16:44:06,702 - jwst.assign_wcs.util - INFO - Excluding off-image object: 99, order 1
2025-09-13 16:44:06,714 - jwst.assign_wcs.util - INFO - Excluding off-image object: 100, order 1
2025-09-13 16:44:06,726 - jwst.assign_wcs.util - INFO - Excluding off-image object: 101, order 1
2025-09-13 16:44:06,738 - jwst.assign_wcs.util - INFO - Excluding off-image object: 102, order 1
2025-09-13 16:44:06,750 - jwst.assign_wcs.util - INFO - Excluding off-image object: 103, order 1
2025-09-13 16:44:06,762 - jwst.assign_wcs.util - INFO - Excluding off-image object: 104, order 1
2025-09-13 16:44:06,774 - jwst.assign_wcs.util - INFO - Excluding off-image object: 105, order 1
2025-09-13 16:44:06,786 - jwst.assign_wcs.util - INFO - Excluding off-image object: 106, order 1
2025-09-13 16:44:06,799 - jwst.assign_wcs.util - INFO - Excluding off-image object: 107, order 1
2025-09-13 16:44:06,811 - jwst.assign_wcs.util - INFO - Excluding off-image object: 108, order 1
2025-09-13 16:44:06,823 - jwst.assign_wcs.util - INFO - Excluding off-image object: 109, order 1
2025-09-13 16:44:06,835 - jwst.assign_wcs.util - INFO - Excluding off-image object: 110, order 1
2025-09-13 16:44:06,847 - jwst.assign_wcs.util - INFO - Excluding off-image object: 111, order 1
2025-09-13 16:44:06,859 - jwst.assign_wcs.util - INFO - Excluding off-image object: 112, order 1
2025-09-13 16:44:06,872 - jwst.assign_wcs.util - INFO - Excluding off-image object: 113, order 1
2025-09-13 16:44:06,884 - jwst.assign_wcs.util - INFO - Excluding off-image object: 114, order 1
2025-09-13 16:44:06,896 - jwst.assign_wcs.util - INFO - Excluding off-image object: 115, order 1
2025-09-13 16:44:06,909 - jwst.assign_wcs.util - INFO - Excluding off-image object: 116, order 1
2025-09-13 16:44:06,921 - jwst.assign_wcs.util - INFO - Excluding off-image object: 117, order 1
2025-09-13 16:44:06,937 - jwst.assign_wcs.util - INFO - Excluding off-image object: 118, order 1
2025-09-13 16:44:06,950 - jwst.assign_wcs.util - INFO - Excluding off-image object: 119, order 1
2025-09-13 16:44:06,962 - jwst.assign_wcs.util - INFO - Excluding off-image object: 120, order 1
2025-09-13 16:44:06,975 - jwst.assign_wcs.util - INFO - Excluding off-image object: 121, order 1
2025-09-13 16:44:06,987 - jwst.assign_wcs.util - INFO - Excluding off-image object: 122, order 1
2025-09-13 16:44:06,999 - jwst.assign_wcs.util - INFO - Excluding off-image object: 123, order 1
2025-09-13 16:44:07,012 - jwst.assign_wcs.util - INFO - Excluding off-image object: 124, order 1
2025-09-13 16:44:07,024 - jwst.assign_wcs.util - INFO - Excluding off-image object: 125, order 1
2025-09-13 16:44:07,037 - jwst.assign_wcs.util - INFO - Excluding off-image object: 126, order 1
2025-09-13 16:44:07,049 - jwst.assign_wcs.util - INFO - Excluding off-image object: 127, order 1
2025-09-13 16:44:07,061 - jwst.assign_wcs.util - INFO - Excluding off-image object: 128, order 1
2025-09-13 16:44:07,073 - jwst.assign_wcs.util - INFO - Excluding off-image object: 129, order 1
2025-09-13 16:44:07,085 - jwst.assign_wcs.util - INFO - Excluding off-image object: 130, order 1
2025-09-13 16:44:07,098 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 131 order: 1
2025-09-13 16:44:07,110 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 132 order: 1
2025-09-13 16:44:07,122 - jwst.assign_wcs.util - INFO - Excluding off-image object: 133, order 1
2025-09-13 16:44:07,135 - jwst.assign_wcs.util - INFO - Excluding off-image object: 134, order 1
2025-09-13 16:44:07,147 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 135 order: 1
2025-09-13 16:44:07,159 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 136 order: 1
2025-09-13 16:44:07,172 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 137 order: 1
2025-09-13 16:44:07,184 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 138 order: 1
2025-09-13 16:44:07,197 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 139 order: 1
2025-09-13 16:44:07,209 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 140 order: 1
2025-09-13 16:44:07,222 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 141 order: 1
2025-09-13 16:44:07,234 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 142 order: 1
2025-09-13 16:44:07,247 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 143 order: 1
2025-09-13 16:44:07,259 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 144 order: 1
2025-09-13 16:44:07,271 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 145 order: 1
2025-09-13 16:44:07,283 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 146 order: 1
2025-09-13 16:44:07,295 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 147 order: 1
2025-09-13 16:44:07,307 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 148 order: 1
2025-09-13 16:44:07,320 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 149 order: 1
2025-09-13 16:44:07,332 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 150 order: 1
2025-09-13 16:44:07,344 - jwst.assign_wcs.util - INFO - Excluding off-image object: 151, order 1
2025-09-13 16:44:07,356 - jwst.assign_wcs.util - INFO - Excluding off-image object: 152, order 1
2025-09-13 16:44:07,368 - jwst.assign_wcs.util - INFO - Excluding off-image object: 153, order 1
2025-09-13 16:44:07,380 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 154 order: 1
2025-09-13 16:44:07,393 - jwst.assign_wcs.util - INFO - Excluding off-image object: 155, order 1
2025-09-13 16:44:07,405 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 156 order: 1
2025-09-13 16:44:07,417 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 157 order: 1
2025-09-13 16:44:07,429 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 158 order: 1
2025-09-13 16:44:07,442 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 159 order: 1
2025-09-13 16:44:07,454 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 160 order: 1
2025-09-13 16:44:07,466 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 161 order: 1
2025-09-13 16:44:07,478 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 162 order: 1
2025-09-13 16:44:07,490 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 163 order: 1
2025-09-13 16:44:07,502 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 164 order: 1
2025-09-13 16:44:07,514 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 165 order: 1
2025-09-13 16:44:07,526 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 166 order: 1
2025-09-13 16:44:07,538 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 167 order: 1
2025-09-13 16:44:07,551 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 168 order: 1
2025-09-13 16:44:07,563 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 169 order: 1
2025-09-13 16:44:07,575 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 170 order: 1
2025-09-13 16:44:07,587 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 171 order: 1
2025-09-13 16:44:07,599 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 172 order: 1
2025-09-13 16:44:07,611 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 173 order: 1
2025-09-13 16:44:07,631 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 174 order: 1
2025-09-13 16:44:07,643 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 175 order: 1
2025-09-13 16:44:07,656 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 176 order: 1
2025-09-13 16:44:07,668 - jwst.assign_wcs.util - INFO - Excluding off-image object: 177, order 1
2025-09-13 16:44:07,680 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 178 order: 1
2025-09-13 16:44:07,693 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 179 order: 1
2025-09-13 16:44:07,705 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 180 order: 1
2025-09-13 16:44:07,717 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 181 order: 1
2025-09-13 16:44:07,729 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 182 order: 1
2025-09-13 16:44:07,741 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 183 order: 1
2025-09-13 16:44:07,753 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 184 order: 1
2025-09-13 16:44:07,765 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 185 order: 1
2025-09-13 16:44:07,777 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 186 order: 1
2025-09-13 16:44:07,790 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 187 order: 1
2025-09-13 16:44:07,802 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 188 order: 1
2025-09-13 16:44:07,814 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 189 order: 1
2025-09-13 16:44:07,826 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 190 order: 1
2025-09-13 16:44:07,838 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 191 order: 1
2025-09-13 16:44:07,850 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 192 order: 1
2025-09-13 16:44:07,862 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 193 order: 1
2025-09-13 16:44:07,875 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 194 order: 1
2025-09-13 16:44:07,887 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 195 order: 1
2025-09-13 16:44:07,899 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 196 order: 1
2025-09-13 16:44:07,911 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 197 order: 1
2025-09-13 16:44:07,923 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 198 order: 1
2025-09-13 16:44:07,935 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 199 order: 1
2025-09-13 16:44:07,947 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 200 order: 1
2025-09-13 16:44:07,960 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 201 order: 1
2025-09-13 16:44:07,972 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 202 order: 1
2025-09-13 16:44:07,984 - jwst.assign_wcs.util - INFO - Excluding off-image object: 203, order 1
2025-09-13 16:44:07,996 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 204 order: 1
2025-09-13 16:44:08,008 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 205 order: 1
2025-09-13 16:44:08,021 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 206 order: 1
2025-09-13 16:44:08,033 - jwst.assign_wcs.util - INFO - Excluding off-image object: 207, order 1
2025-09-13 16:44:08,045 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 208 order: 1
2025-09-13 16:44:08,174 - jwst.assign_wcs.util - INFO - Excluding off-image object: 219, order 1
2025-09-13 16:44:08,237 - jwst.assign_wcs.util - INFO - Excluding off-image object: 224, order 1
2025-09-13 16:44:08,319 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 231 order: 1
2025-09-13 16:44:08,519 - jwst.assign_wcs.util - INFO - Excluding off-image object: 248, order 1
2025-09-13 16:44:09,175 - jwst.assign_wcs.util - INFO - Excluding off-image object: 304, order 1
2025-09-13 16:44:09,187 - jwst.assign_wcs.util - INFO - Excluding off-image object: 305, order 1
2025-09-13 16:44:09,200 - jwst.assign_wcs.util - INFO - Excluding off-image object: 306, order 1
2025-09-13 16:44:09,415 - jwst.assign_wcs.util - INFO - Excluding off-image object: 324, order 1
2025-09-13 16:44:09,475 - jwst.assign_wcs.util - INFO - Excluding off-image object: 329, order 1
2025-09-13 16:44:09,823 - jwst.assign_wcs.util - INFO - Excluding off-image object: 358, order 1
2025-09-13 16:44:09,907 - jwst.assign_wcs.util - INFO - Excluding off-image object: 365, order 1
2025-09-13 16:44:09,968 - jwst.assign_wcs.util - INFO - Excluding off-image object: 370, order 1
2025-09-13 16:44:09,982 - jwst.assign_wcs.util - INFO - Excluding off-image object: 371, order 1
2025-09-13 16:44:10,863 - jwst.assign_wcs.util - INFO - Excluding off-image object: 445, order 1
2025-09-13 16:44:10,912 - jwst.assign_wcs.util - INFO - Excluding off-image object: 449, order 1
2025-09-13 16:44:11,151 - jwst.assign_wcs.util - INFO - Excluding off-image object: 469, order 1
2025-09-13 16:44:11,343 - jwst.assign_wcs.util - INFO - Excluding off-image object: 485, order 1
2025-09-13 16:44:11,508 - jwst.assign_wcs.util - INFO - Excluding off-image object: 499, order 1
2025-09-13 16:44:12,485 - jwst.assign_wcs.util - INFO - Excluding off-image object: 582, order 1
2025-09-13 16:44:12,710 - jwst.assign_wcs.util - INFO - Excluding off-image object: 601, order 1
2025-09-13 16:44:12,804 - jwst.assign_wcs.util - INFO - Excluding off-image object: 609, order 1
2025-09-13 16:44:12,816 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 610 order: 1
2025-09-13 16:44:13,249 - jwst.assign_wcs.util - INFO - Excluding off-image object: 647, order 1
2025-09-13 16:44:13,402 - jwst.assign_wcs.util - INFO - Excluding off-image object: 660, order 1
2025-09-13 16:44:13,462 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 665 order: 1
2025-09-13 16:44:13,557 - jwst.assign_wcs.util - INFO - Excluding off-image object: 673, order 1
2025-09-13 16:44:13,828 - jwst.assign_wcs.util - INFO - Excluding off-image object: 696, order 1
2025-09-13 16:44:13,864 - jwst.assign_wcs.util - INFO - Excluding off-image object: 699, order 1
2025-09-13 16:44:14,063 - jwst.assign_wcs.util - INFO - Excluding off-image object: 716, order 1
2025-09-13 16:44:14,157 - jwst.assign_wcs.util - INFO - Excluding off-image object: 724, order 1
2025-09-13 16:44:14,368 - jwst.assign_wcs.util - INFO - Excluding off-image object: 742, order 1
2025-09-13 16:44:14,380 - jwst.assign_wcs.util - INFO - Excluding off-image object: 743, order 1
2025-09-13 16:44:14,580 - jwst.assign_wcs.util - INFO - Excluding off-image object: 760, order 1
2025-09-13 16:44:15,406 - jwst.assign_wcs.util - INFO - Excluding off-image object: 830, order 1
2025-09-13 16:44:15,447 - jwst.assign_wcs.util - INFO - Excluding off-image object: 833, order 1
2025-09-13 16:44:15,578 - jwst.assign_wcs.util - INFO - Excluding off-image object: 844, order 1
2025-09-13 16:44:15,699 - jwst.assign_wcs.util - INFO - Excluding off-image object: 854, order 1
2025-09-13 16:44:15,988 - jwst.assign_wcs.util - INFO - Excluding off-image object: 878, order 1
2025-09-13 16:44:16,182 - jwst.assign_wcs.util - INFO - Excluding off-image object: 894, order 1
2025-09-13 16:44:16,278 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 902 order: 1
2025-09-13 16:44:16,461 - jwst.assign_wcs.util - INFO - Excluding off-image object: 917, order 1
2025-09-13 16:44:16,497 - jwst.assign_wcs.util - INFO - Excluding off-image object: 920, order 1
2025-09-13 16:44:16,841 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 949 order: 1
2025-09-13 16:44:16,900 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 954 order: 1
2025-09-13 16:44:17,285 - jwst.assign_wcs.util - INFO - Excluding off-image object: 986, order 1
2025-09-13 16:44:17,383 - jwst.assign_wcs.util - INFO - Excluding off-image object: 994, order 1
2025-09-13 16:44:17,468 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1001, order 1
2025-09-13 16:44:17,589 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1011 order: 1
2025-09-13 16:44:17,639 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1015, order 1
2025-09-13 16:44:17,677 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1018, order 1
2025-09-13 16:44:17,703 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1020, order 1
2025-09-13 16:44:17,873 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1034, order 1
2025-09-13 16:44:18,056 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1049 order: 1
2025-09-13 16:44:18,081 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1051 order: 1
2025-09-13 16:44:18,576 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1093, order 1
2025-09-13 16:44:18,624 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1097, order 1
2025-09-13 16:44:18,696 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1103, order 1
2025-09-13 16:44:18,778 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1110, order 1
2025-09-13 16:44:19,292 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1154, order 1
2025-09-13 16:44:19,328 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1157, order 1
2025-09-13 16:44:19,468 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1169, order 1
2025-09-13 16:44:19,516 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1173, order 1
2025-09-13 16:44:19,587 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1179, order 1
2025-09-13 16:44:19,857 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1202, order 1
2025-09-13 16:44:19,893 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1205, order 1
2025-09-13 16:44:19,964 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1211, order 1
2025-09-13 16:44:20,107 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1223, order 1
2025-09-13 16:44:20,167 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1228, order 1
2025-09-13 16:44:20,228 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1233, order 1
2025-09-13 16:44:20,857 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1286, order 1
2025-09-13 16:44:21,262 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1320, order 1
2025-09-13 16:44:21,298 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1323, order 1
2025-09-13 16:44:21,957 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1379, order 1
2025-09-13 16:44:22,028 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1385 order: 1
2025-09-13 16:44:22,501 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1425, order 1
2025-09-13 16:44:22,691 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1441, order 1
2025-09-13 16:44:22,786 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1449 order: 1
2025-09-13 16:44:23,108 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1476 order: 1
2025-09-13 16:44:23,144 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1479 order: 1
2025-09-13 16:44:23,240 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1487, order 1
2025-09-13 16:44:23,287 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1491 order: 1
2025-09-13 16:44:23,300 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1492 order: 1
2025-09-13 16:44:23,313 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1493 order: 1
2025-09-13 16:44:23,326 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1494 order: 1
2025-09-13 16:44:23,339 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1495 order: 1
2025-09-13 16:44:23,352 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1496 order: 1
2025-09-13 16:44:23,365 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1497 order: 1
2025-09-13 16:44:23,378 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1498 order: 1
2025-09-13 16:44:23,390 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1499 order: 1
2025-09-13 16:44:23,403 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1500 order: 1
2025-09-13 16:44:23,415 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1501 order: 1
2025-09-13 16:44:23,428 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1502 order: 1
2025-09-13 16:44:23,429 - jwst.assign_wcs.util - INFO - Total of 1297 grism objects defined
2025-09-13 16:44:23,471 - jwst.background.background_sub_wfss - INFO - Starting iterative outlier rejection for background subtraction.
2025-09-13 16:44:24,058 - jwst.background.background_sub_wfss - INFO - Stopped at maxiter (5).
2025-09-13 16:44:24,241 - jwst.background.background_sub_wfss - INFO - Average of scaled background image = 4.445e-01
2025-09-13 16:44:24,241 - jwst.background.background_sub_wfss - INFO - Scaling factor = 4.63482e-01
2025-09-13 16:44:24,247 - stpipe.Spec2Pipeline.bkg_subtract - INFO - Step bkg_subtract done
2025-09-13 16:44:24,683 - stpipe.Spec2Pipeline.flat_field - INFO - Step flat_field running with args (<ImageModel(2048, 2048) from jw02079004003_03101_00001_nis_rate.fits>,).
2025-09-13 16:44:24,759 - stpipe.Spec2Pipeline.flat_field - INFO - Using FLAT reference file: /home/runner/crds/references/jwst/niriss/jwst_niriss_flat_0271.fits
2025-09-13 16:44:24,760 - stpipe.Spec2Pipeline.flat_field - INFO - No reference found for type FFLAT
2025-09-13 16:44:24,760 - stpipe.Spec2Pipeline.flat_field - INFO - No reference found for type SFLAT
2025-09-13 16:44:24,761 - stpipe.Spec2Pipeline.flat_field - INFO - No reference found for type DFLAT
2025-09-13 16:44:24,981 - stpipe.Spec2Pipeline.flat_field - INFO - Step flat_field done
2025-09-13 16:44:25,410 - stpipe.Spec2Pipeline.extract_2d - INFO - Step extract_2d running with args (<ImageModel(2048, 2048) from jw02079004003_03101_00001_nis_rate.fits>,).
2025-09-13 16:44:25,421 - jwst.extract_2d.extract_2d - INFO - EXP_TYPE is NIS_WFSS
2025-09-13 16:44:25,432 - jwst.assign_wcs.util - INFO - Getting objects from jw02079-o004_niriss_clear-f200w_cat.ecsv
2025-09-13 16:44:25,744 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1, order 1
2025-09-13 16:44:25,756 - jwst.assign_wcs.util - INFO - Excluding off-image object: 2, order 1
2025-09-13 16:44:25,766 - jwst.assign_wcs.util - INFO - Excluding off-image object: 3, order 1
2025-09-13 16:44:25,777 - jwst.assign_wcs.util - INFO - Excluding off-image object: 4, order 1
2025-09-13 16:44:25,789 - jwst.assign_wcs.util - INFO - Excluding off-image object: 5, order 1
2025-09-13 16:44:25,801 - jwst.assign_wcs.util - INFO - Excluding off-image object: 6, order 1
2025-09-13 16:44:25,813 - jwst.assign_wcs.util - INFO - Excluding off-image object: 7, order 1
2025-09-13 16:44:25,825 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 8 order: 1
2025-09-13 16:44:25,837 - jwst.assign_wcs.util - INFO - Excluding off-image object: 9, order 1
2025-09-13 16:44:25,849 - jwst.assign_wcs.util - INFO - Excluding off-image object: 10, order 1
2025-09-13 16:44:25,860 - jwst.assign_wcs.util - INFO - Excluding off-image object: 11, order 1
2025-09-13 16:44:25,873 - jwst.assign_wcs.util - INFO - Excluding off-image object: 12, order 1
2025-09-13 16:44:25,885 - jwst.assign_wcs.util - INFO - Excluding off-image object: 13, order 1
2025-09-13 16:44:25,897 - jwst.assign_wcs.util - INFO - Excluding off-image object: 14, order 1
2025-09-13 16:44:25,909 - jwst.assign_wcs.util - INFO - Excluding off-image object: 15, order 1
2025-09-13 16:44:25,921 - jwst.assign_wcs.util - INFO - Excluding off-image object: 16, order 1
2025-09-13 16:44:25,933 - jwst.assign_wcs.util - INFO - Excluding off-image object: 17, order 1
2025-09-13 16:44:25,945 - jwst.assign_wcs.util - INFO - Excluding off-image object: 18, order 1
2025-09-13 16:44:25,956 - jwst.assign_wcs.util - INFO - Excluding off-image object: 19, order 1
2025-09-13 16:44:25,968 - jwst.assign_wcs.util - INFO - Excluding off-image object: 20, order 1
2025-09-13 16:44:25,980 - jwst.assign_wcs.util - INFO - Excluding off-image object: 21, order 1
2025-09-13 16:44:25,992 - jwst.assign_wcs.util - INFO - Excluding off-image object: 22, order 1
2025-09-13 16:44:26,004 - jwst.assign_wcs.util - INFO - Excluding off-image object: 23, order 1
2025-09-13 16:44:26,016 - jwst.assign_wcs.util - INFO - Excluding off-image object: 24, order 1
2025-09-13 16:44:26,028 - jwst.assign_wcs.util - INFO - Excluding off-image object: 25, order 1
2025-09-13 16:44:26,037 - jwst.assign_wcs.util - INFO - Excluding off-image object: 26, order 1
2025-09-13 16:44:26,049 - jwst.assign_wcs.util - INFO - Excluding off-image object: 27, order 1
2025-09-13 16:44:26,060 - jwst.assign_wcs.util - INFO - Excluding off-image object: 28, order 1
2025-09-13 16:44:26,073 - jwst.assign_wcs.util - INFO - Excluding off-image object: 29, order 1
2025-09-13 16:44:26,084 - jwst.assign_wcs.util - INFO - Excluding off-image object: 30, order 1
2025-09-13 16:44:26,093 - jwst.assign_wcs.util - INFO - Excluding off-image object: 31, order 1
2025-09-13 16:44:26,105 - jwst.assign_wcs.util - INFO - Excluding off-image object: 32, order 1
2025-09-13 16:44:26,114 - jwst.assign_wcs.util - INFO - Excluding off-image object: 33, order 1
2025-09-13 16:44:26,126 - jwst.assign_wcs.util - INFO - Excluding off-image object: 34, order 1
2025-09-13 16:44:26,137 - jwst.assign_wcs.util - INFO - Excluding off-image object: 35, order 1
2025-09-13 16:44:26,146 - jwst.assign_wcs.util - INFO - Excluding off-image object: 36, order 1
2025-09-13 16:44:26,158 - jwst.assign_wcs.util - INFO - Excluding off-image object: 37, order 1
2025-09-13 16:44:26,167 - jwst.assign_wcs.util - INFO - Excluding off-image object: 38, order 1
2025-09-13 16:44:26,180 - jwst.assign_wcs.util - INFO - Excluding off-image object: 39, order 1
2025-09-13 16:44:26,191 - jwst.assign_wcs.util - INFO - Excluding off-image object: 40, order 1
2025-09-13 16:44:26,203 - jwst.assign_wcs.util - INFO - Excluding off-image object: 41, order 1
2025-09-13 16:44:26,212 - jwst.assign_wcs.util - INFO - Excluding off-image object: 42, order 1
2025-09-13 16:44:26,221 - jwst.assign_wcs.util - INFO - Excluding off-image object: 43, order 1
2025-09-13 16:44:26,233 - jwst.assign_wcs.util - INFO - Excluding off-image object: 44, order 1
2025-09-13 16:44:26,244 - jwst.assign_wcs.util - INFO - Excluding off-image object: 45, order 1
2025-09-13 16:44:26,253 - jwst.assign_wcs.util - INFO - Excluding off-image object: 46, order 1
2025-09-13 16:44:26,265 - jwst.assign_wcs.util - INFO - Excluding off-image object: 47, order 1
2025-09-13 16:44:26,273 - jwst.assign_wcs.util - INFO - Excluding off-image object: 48, order 1
2025-09-13 16:44:26,285 - jwst.assign_wcs.util - INFO - Excluding off-image object: 49, order 1
2025-09-13 16:44:26,294 - jwst.assign_wcs.util - INFO - Excluding off-image object: 50, order 1
2025-09-13 16:44:26,303 - jwst.assign_wcs.util - INFO - Excluding off-image object: 51, order 1
2025-09-13 16:44:26,314 - jwst.assign_wcs.util - INFO - Excluding off-image object: 52, order 1
2025-09-13 16:44:26,323 - jwst.assign_wcs.util - INFO - Excluding off-image object: 53, order 1
2025-09-13 16:44:26,335 - jwst.assign_wcs.util - INFO - Excluding off-image object: 54, order 1
2025-09-13 16:44:26,344 - jwst.assign_wcs.util - INFO - Excluding off-image object: 55, order 1
2025-09-13 16:44:26,353 - jwst.assign_wcs.util - INFO - Excluding off-image object: 56, order 1
2025-09-13 16:44:26,365 - jwst.assign_wcs.util - INFO - Excluding off-image object: 57, order 1
2025-09-13 16:44:26,377 - jwst.assign_wcs.util - INFO - Excluding off-image object: 58, order 1
2025-09-13 16:44:26,385 - jwst.assign_wcs.util - INFO - Excluding off-image object: 59, order 1
2025-09-13 16:44:26,394 - jwst.assign_wcs.util - INFO - Excluding off-image object: 60, order 1
2025-09-13 16:44:26,403 - jwst.assign_wcs.util - INFO - Excluding off-image object: 61, order 1
2025-09-13 16:44:26,412 - jwst.assign_wcs.util - INFO - Excluding off-image object: 62, order 1
2025-09-13 16:44:26,424 - jwst.assign_wcs.util - INFO - Excluding off-image object: 63, order 1
2025-09-13 16:44:26,435 - jwst.assign_wcs.util - INFO - Excluding off-image object: 64, order 1
2025-09-13 16:44:26,444 - jwst.assign_wcs.util - INFO - Excluding off-image object: 65, order 1
2025-09-13 16:44:26,456 - jwst.assign_wcs.util - INFO - Excluding off-image object: 66, order 1
2025-09-13 16:44:26,465 - jwst.assign_wcs.util - INFO - Excluding off-image object: 67, order 1
2025-09-13 16:44:26,474 - jwst.assign_wcs.util - INFO - Excluding off-image object: 68, order 1
2025-09-13 16:44:26,486 - jwst.assign_wcs.util - INFO - Excluding off-image object: 69, order 1
2025-09-13 16:44:26,497 - jwst.assign_wcs.util - INFO - Excluding off-image object: 70, order 1
2025-09-13 16:44:26,509 - jwst.assign_wcs.util - INFO - Excluding off-image object: 71, order 1
2025-09-13 16:44:26,518 - jwst.assign_wcs.util - INFO - Excluding off-image object: 72, order 1
2025-09-13 16:44:26,527 - jwst.assign_wcs.util - INFO - Excluding off-image object: 73, order 1
2025-09-13 16:44:26,536 - jwst.assign_wcs.util - INFO - Excluding off-image object: 74, order 1
2025-09-13 16:44:26,545 - jwst.assign_wcs.util - INFO - Excluding off-image object: 75, order 1
2025-09-13 16:44:26,553 - jwst.assign_wcs.util - INFO - Excluding off-image object: 76, order 1
2025-09-13 16:44:26,565 - jwst.assign_wcs.util - INFO - Excluding off-image object: 77, order 1
2025-09-13 16:44:26,577 - jwst.assign_wcs.util - INFO - Excluding off-image object: 78, order 1
2025-09-13 16:44:26,586 - jwst.assign_wcs.util - INFO - Excluding off-image object: 79, order 1
2025-09-13 16:44:26,598 - jwst.assign_wcs.util - INFO - Excluding off-image object: 80, order 1
2025-09-13 16:44:26,607 - jwst.assign_wcs.util - INFO - Excluding off-image object: 81, order 1
2025-09-13 16:44:26,616 - jwst.assign_wcs.util - INFO - Excluding off-image object: 82, order 1
2025-09-13 16:44:26,627 - jwst.assign_wcs.util - INFO - Excluding off-image object: 83, order 1
2025-09-13 16:44:26,637 - jwst.assign_wcs.util - INFO - Excluding off-image object: 84, order 1
2025-09-13 16:44:26,646 - jwst.assign_wcs.util - INFO - Excluding off-image object: 85, order 1
2025-09-13 16:44:26,655 - jwst.assign_wcs.util - INFO - Excluding off-image object: 86, order 1
2025-09-13 16:44:26,666 - jwst.assign_wcs.util - INFO - Excluding off-image object: 87, order 1
2025-09-13 16:44:26,675 - jwst.assign_wcs.util - INFO - Excluding off-image object: 88, order 1
2025-09-13 16:44:26,684 - jwst.assign_wcs.util - INFO - Excluding off-image object: 89, order 1
2025-09-13 16:44:26,696 - jwst.assign_wcs.util - INFO - Excluding off-image object: 90, order 1
2025-09-13 16:44:26,705 - jwst.assign_wcs.util - INFO - Excluding off-image object: 91, order 1
2025-09-13 16:44:26,717 - jwst.assign_wcs.util - INFO - Excluding off-image object: 92, order 1
2025-09-13 16:44:26,726 - jwst.assign_wcs.util - INFO - Excluding off-image object: 93, order 1
2025-09-13 16:44:26,735 - jwst.assign_wcs.util - INFO - Excluding off-image object: 94, order 1
2025-09-13 16:44:26,744 - jwst.assign_wcs.util - INFO - Excluding off-image object: 95, order 1
2025-09-13 16:44:26,756 - jwst.assign_wcs.util - INFO - Excluding off-image object: 96, order 1
2025-09-13 16:44:26,768 - jwst.assign_wcs.util - INFO - Excluding off-image object: 97, order 1
2025-09-13 16:44:26,777 - jwst.assign_wcs.util - INFO - Excluding off-image object: 98, order 1
2025-09-13 16:44:26,786 - jwst.assign_wcs.util - INFO - Excluding off-image object: 99, order 1
2025-09-13 16:44:26,795 - jwst.assign_wcs.util - INFO - Excluding off-image object: 100, order 1
2025-09-13 16:44:26,804 - jwst.assign_wcs.util - INFO - Excluding off-image object: 101, order 1
2025-09-13 16:44:26,813 - jwst.assign_wcs.util - INFO - Excluding off-image object: 102, order 1
2025-09-13 16:44:26,822 - jwst.assign_wcs.util - INFO - Excluding off-image object: 103, order 1
2025-09-13 16:44:26,832 - jwst.assign_wcs.util - INFO - Excluding off-image object: 104, order 1
2025-09-13 16:44:26,844 - jwst.assign_wcs.util - INFO - Excluding off-image object: 105, order 1
2025-09-13 16:44:26,853 - jwst.assign_wcs.util - INFO - Excluding off-image object: 106, order 1
2025-09-13 16:44:26,862 - jwst.assign_wcs.util - INFO - Excluding off-image object: 107, order 1
2025-09-13 16:44:26,874 - jwst.assign_wcs.util - INFO - Excluding off-image object: 108, order 1
2025-09-13 16:44:26,883 - jwst.assign_wcs.util - INFO - Excluding off-image object: 109, order 1
2025-09-13 16:44:26,894 - jwst.assign_wcs.util - INFO - Excluding off-image object: 110, order 1
2025-09-13 16:44:26,903 - jwst.assign_wcs.util - INFO - Excluding off-image object: 111, order 1
2025-09-13 16:44:26,912 - jwst.assign_wcs.util - INFO - Excluding off-image object: 112, order 1
2025-09-13 16:44:26,921 - jwst.assign_wcs.util - INFO - Excluding off-image object: 113, order 1
2025-09-13 16:44:26,929 - jwst.assign_wcs.util - INFO - Excluding off-image object: 114, order 1
2025-09-13 16:44:26,938 - jwst.assign_wcs.util - INFO - Excluding off-image object: 115, order 1
2025-09-13 16:44:26,947 - jwst.assign_wcs.util - INFO - Excluding off-image object: 116, order 1
2025-09-13 16:44:26,956 - jwst.assign_wcs.util - INFO - Excluding off-image object: 117, order 1
2025-09-13 16:44:26,965 - jwst.assign_wcs.util - INFO - Excluding off-image object: 118, order 1
2025-09-13 16:44:26,974 - jwst.assign_wcs.util - INFO - Excluding off-image object: 119, order 1
2025-09-13 16:44:26,986 - jwst.assign_wcs.util - INFO - Excluding off-image object: 120, order 1
2025-09-13 16:44:26,995 - jwst.assign_wcs.util - INFO - Excluding off-image object: 121, order 1
2025-09-13 16:44:27,007 - jwst.assign_wcs.util - INFO - Excluding off-image object: 122, order 1
2025-09-13 16:44:27,016 - jwst.assign_wcs.util - INFO - Excluding off-image object: 123, order 1
2025-09-13 16:44:27,025 - jwst.assign_wcs.util - INFO - Excluding off-image object: 124, order 1
2025-09-13 16:44:27,034 - jwst.assign_wcs.util - INFO - Excluding off-image object: 125, order 1
2025-09-13 16:44:27,042 - jwst.assign_wcs.util - INFO - Excluding off-image object: 126, order 1
2025-09-13 16:44:27,051 - jwst.assign_wcs.util - INFO - Excluding off-image object: 127, order 1
2025-09-13 16:44:27,060 - jwst.assign_wcs.util - INFO - Excluding off-image object: 128, order 1
2025-09-13 16:44:27,072 - jwst.assign_wcs.util - INFO - Excluding off-image object: 129, order 1
2025-09-13 16:44:27,081 - jwst.assign_wcs.util - INFO - Excluding off-image object: 130, order 1
2025-09-13 16:44:27,089 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 131 order: 1
2025-09-13 16:44:27,098 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 132 order: 1
2025-09-13 16:44:27,107 - jwst.assign_wcs.util - INFO - Excluding off-image object: 133, order 1
2025-09-13 16:44:27,116 - jwst.assign_wcs.util - INFO - Excluding off-image object: 134, order 1
2025-09-13 16:44:27,125 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 135 order: 1
2025-09-13 16:44:27,136 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 136 order: 1
2025-09-13 16:44:27,148 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 137 order: 1
2025-09-13 16:44:27,160 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 138 order: 1
2025-09-13 16:44:27,172 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 139 order: 1
2025-09-13 16:44:27,181 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 140 order: 1
2025-09-13 16:44:27,190 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 141 order: 1
2025-09-13 16:44:27,202 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 142 order: 1
2025-09-13 16:44:27,211 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 143 order: 1
2025-09-13 16:44:27,223 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 144 order: 1
2025-09-13 16:44:27,235 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 145 order: 1
2025-09-13 16:44:27,244 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 146 order: 1
2025-09-13 16:44:27,256 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 147 order: 1
2025-09-13 16:44:27,265 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 148 order: 1
2025-09-13 16:44:27,274 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 149 order: 1
2025-09-13 16:44:27,283 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 150 order: 1
2025-09-13 16:44:27,292 - jwst.assign_wcs.util - INFO - Excluding off-image object: 151, order 1
2025-09-13 16:44:27,303 - jwst.assign_wcs.util - INFO - Excluding off-image object: 152, order 1
2025-09-13 16:44:27,315 - jwst.assign_wcs.util - INFO - Excluding off-image object: 153, order 1
2025-09-13 16:44:27,324 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 154 order: 1
2025-09-13 16:44:27,336 - jwst.assign_wcs.util - INFO - Excluding off-image object: 155, order 1
2025-09-13 16:44:27,345 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 156 order: 1
2025-09-13 16:44:27,354 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 157 order: 1
2025-09-13 16:44:27,363 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 158 order: 1
2025-09-13 16:44:27,372 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 159 order: 1
2025-09-13 16:44:27,381 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 160 order: 1
2025-09-13 16:44:27,390 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 161 order: 1
2025-09-13 16:44:27,399 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 162 order: 1
2025-09-13 16:44:27,407 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 163 order: 1
2025-09-13 16:44:27,419 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 164 order: 1
2025-09-13 16:44:27,431 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 165 order: 1
2025-09-13 16:44:27,440 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 166 order: 1
2025-09-13 16:44:27,452 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 167 order: 1
2025-09-13 16:44:27,461 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 168 order: 1
2025-09-13 16:44:27,470 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 169 order: 1
2025-09-13 16:44:27,480 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 170 order: 1
2025-09-13 16:44:27,489 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 171 order: 1
2025-09-13 16:44:27,498 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 172 order: 1
2025-09-13 16:44:27,510 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 173 order: 1
2025-09-13 16:44:27,519 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 174 order: 1
2025-09-13 16:44:27,529 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 175 order: 1
2025-09-13 16:44:27,541 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 176 order: 1
2025-09-13 16:44:27,550 - jwst.assign_wcs.util - INFO - Excluding off-image object: 177, order 1
2025-09-13 16:44:27,559 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 178 order: 1
2025-09-13 16:44:27,569 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 179 order: 1
2025-09-13 16:44:27,578 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 180 order: 1
2025-09-13 16:44:27,590 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 181 order: 1
2025-09-13 16:44:27,601 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 182 order: 1
2025-09-13 16:44:27,611 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 183 order: 1
2025-09-13 16:44:27,623 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 184 order: 1
2025-09-13 16:44:27,631 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 185 order: 1
2025-09-13 16:44:27,640 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 186 order: 1
2025-09-13 16:44:27,652 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 187 order: 1
2025-09-13 16:44:27,661 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 188 order: 1
2025-09-13 16:44:27,670 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 189 order: 1
2025-09-13 16:44:27,682 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 190 order: 1
2025-09-13 16:44:27,691 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 191 order: 1
2025-09-13 16:44:27,700 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 192 order: 1
2025-09-13 16:44:27,709 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 193 order: 1
2025-09-13 16:44:27,718 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 194 order: 1
2025-09-13 16:44:27,727 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 195 order: 1
2025-09-13 16:44:27,736 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 196 order: 1
2025-09-13 16:44:27,745 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 197 order: 1
2025-09-13 16:44:27,754 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 198 order: 1
2025-09-13 16:44:27,766 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 199 order: 1
2025-09-13 16:44:27,775 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 200 order: 1
2025-09-13 16:44:27,784 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 201 order: 1
2025-09-13 16:44:27,793 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 202 order: 1
2025-09-13 16:44:27,802 - jwst.assign_wcs.util - INFO - Excluding off-image object: 203, order 1
2025-09-13 16:44:27,811 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 204 order: 1
2025-09-13 16:44:27,820 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 205 order: 1
2025-09-13 16:44:27,829 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 206 order: 1
2025-09-13 16:44:27,838 - jwst.assign_wcs.util - INFO - Excluding off-image object: 207, order 1
2025-09-13 16:44:27,847 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 208 order: 1
2025-09-13 16:44:27,948 - jwst.assign_wcs.util - INFO - Excluding off-image object: 219, order 1
2025-09-13 16:44:27,999 - jwst.assign_wcs.util - INFO - Excluding off-image object: 224, order 1
2025-09-13 16:44:28,064 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 231 order: 1
2025-09-13 16:44:28,224 - jwst.assign_wcs.util - INFO - Excluding off-image object: 248, order 1
2025-09-13 16:44:28,739 - jwst.assign_wcs.util - INFO - Excluding off-image object: 304, order 1
2025-09-13 16:44:28,751 - jwst.assign_wcs.util - INFO - Excluding off-image object: 305, order 1
2025-09-13 16:44:28,763 - jwst.assign_wcs.util - INFO - Excluding off-image object: 306, order 1
2025-09-13 16:44:28,927 - jwst.assign_wcs.util - INFO - Excluding off-image object: 324, order 1
2025-09-13 16:44:28,975 - jwst.assign_wcs.util - INFO - Excluding off-image object: 329, order 1
2025-09-13 16:44:29,245 - jwst.assign_wcs.util - INFO - Excluding off-image object: 358, order 1
2025-09-13 16:44:29,307 - jwst.assign_wcs.util - INFO - Excluding off-image object: 365, order 1
2025-09-13 16:44:29,358 - jwst.assign_wcs.util - INFO - Excluding off-image object: 370, order 1
2025-09-13 16:44:29,371 - jwst.assign_wcs.util - INFO - Excluding off-image object: 371, order 1
2025-09-13 16:44:30,065 - jwst.assign_wcs.util - INFO - Excluding off-image object: 445, order 1
2025-09-13 16:44:30,102 - jwst.assign_wcs.util - INFO - Excluding off-image object: 449, order 1
2025-09-13 16:44:30,291 - jwst.assign_wcs.util - INFO - Excluding off-image object: 469, order 1
2025-09-13 16:44:30,436 - jwst.assign_wcs.util - INFO - Excluding off-image object: 485, order 1
2025-09-13 16:44:30,564 - jwst.assign_wcs.util - INFO - Excluding off-image object: 499, order 1
2025-09-13 16:44:31,323 - jwst.assign_wcs.util - INFO - Excluding off-image object: 582, order 1
2025-09-13 16:44:31,503 - jwst.assign_wcs.util - INFO - Excluding off-image object: 601, order 1
2025-09-13 16:44:31,581 - jwst.assign_wcs.util - INFO - Excluding off-image object: 609, order 1
2025-09-13 16:44:31,593 - jwst.assign_wcs.util - INFO - Excluding off-image object: 610, order 1
2025-09-13 16:44:31,948 - jwst.assign_wcs.util - INFO - Excluding off-image object: 647, order 1
2025-09-13 16:44:32,079 - jwst.assign_wcs.util - INFO - Excluding off-image object: 660, order 1
2025-09-13 16:44:32,128 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 665 order: 1
2025-09-13 16:44:32,181 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 670 order: 1
2025-09-13 16:44:32,208 - jwst.assign_wcs.util - INFO - Excluding off-image object: 673, order 1
2025-09-13 16:44:32,412 - jwst.assign_wcs.util - INFO - Excluding off-image object: 696, order 1
2025-09-13 16:44:32,441 - jwst.assign_wcs.util - INFO - Excluding off-image object: 699, order 1
2025-09-13 16:44:32,597 - jwst.assign_wcs.util - INFO - Excluding off-image object: 716, order 1
2025-09-13 16:44:32,668 - jwst.assign_wcs.util - INFO - Excluding off-image object: 724, order 1
2025-09-13 16:44:32,791 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 738 order: 1
2025-09-13 16:44:32,825 - jwst.assign_wcs.util - INFO - Excluding off-image object: 742, order 1
2025-09-13 16:44:32,834 - jwst.assign_wcs.util - INFO - Excluding off-image object: 743, order 1
2025-09-13 16:44:32,986 - jwst.assign_wcs.util - INFO - Excluding off-image object: 760, order 1
2025-09-13 16:44:33,609 - jwst.assign_wcs.util - INFO - Excluding off-image object: 830, order 1
2025-09-13 16:44:33,637 - jwst.assign_wcs.util - INFO - Excluding off-image object: 833, order 1
2025-09-13 16:44:33,736 - jwst.assign_wcs.util - INFO - Excluding off-image object: 844, order 1
2025-09-13 16:44:33,826 - jwst.assign_wcs.util - INFO - Excluding off-image object: 854, order 1
2025-09-13 16:44:34,053 - jwst.assign_wcs.util - INFO - Excluding off-image object: 878, order 1
2025-09-13 16:44:34,202 - jwst.assign_wcs.util - INFO - Excluding off-image object: 894, order 1
2025-09-13 16:44:34,275 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 902 order: 1
2025-09-13 16:44:34,407 - jwst.assign_wcs.util - INFO - Excluding off-image object: 917, order 1
2025-09-13 16:44:34,432 - jwst.assign_wcs.util - INFO - Excluding off-image object: 920, order 1
2025-09-13 16:44:34,686 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 949 order: 1
2025-09-13 16:44:34,734 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 954 order: 1
2025-09-13 16:44:35,017 - jwst.assign_wcs.util - INFO - Excluding off-image object: 986, order 1
2025-09-13 16:44:35,087 - jwst.assign_wcs.util - INFO - Excluding off-image object: 994, order 1
2025-09-13 16:44:35,148 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1001, order 1
2025-09-13 16:44:35,239 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1011 order: 1
2025-09-13 16:44:35,275 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1015, order 1
2025-09-13 16:44:35,304 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1018, order 1
2025-09-13 16:44:35,321 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1020, order 1
2025-09-13 16:44:35,453 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1034, order 1
2025-09-13 16:44:35,590 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1049 order: 1
2025-09-13 16:44:35,610 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1051 order: 1
2025-09-13 16:44:35,992 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1093, order 1
2025-09-13 16:44:36,031 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1097, order 1
2025-09-13 16:44:36,085 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1103, order 1
2025-09-13 16:44:36,155 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1110, order 1
2025-09-13 16:44:36,545 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1154, order 1
2025-09-13 16:44:36,577 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1157, order 1
2025-09-13 16:44:36,684 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1169, order 1
2025-09-13 16:44:36,718 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1173, order 1
2025-09-13 16:44:36,771 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1179, order 1
2025-09-13 16:44:36,975 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1202, order 1
2025-09-13 16:44:37,003 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1205, order 1
2025-09-13 16:44:37,059 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1211, order 1
2025-09-13 16:44:37,171 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1223, order 1
2025-09-13 16:44:37,216 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1228, order 1
2025-09-13 16:44:37,261 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1233, order 1
2025-09-13 16:44:37,743 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1286, order 1
2025-09-13 16:44:38,057 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1320, order 1
2025-09-13 16:44:38,088 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1323, order 1
2025-09-13 16:44:38,608 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1379, order 1
2025-09-13 16:44:38,665 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1385 order: 1
2025-09-13 16:44:39,032 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1425, order 1
2025-09-13 16:44:39,184 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1441, order 1
2025-09-13 16:44:39,256 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1449 order: 1
2025-09-13 16:44:39,512 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1476 order: 1
2025-09-13 16:44:39,541 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1479 order: 1
2025-09-13 16:44:39,611 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1487, order 1
2025-09-13 16:44:39,652 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1491 order: 1
2025-09-13 16:44:39,661 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1492 order: 1
2025-09-13 16:44:39,670 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1493 order: 1
2025-09-13 16:44:39,679 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1494 order: 1
2025-09-13 16:44:39,688 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1495 order: 1
2025-09-13 16:44:39,697 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1496 order: 1
2025-09-13 16:44:39,706 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1497 order: 1
2025-09-13 16:44:39,715 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1498 order: 1
2025-09-13 16:44:39,724 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1499 order: 1
2025-09-13 16:44:39,735 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1500 order: 1
2025-09-13 16:44:39,747 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1501 order: 1
2025-09-13 16:44:39,758 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1502 order: 1
2025-09-13 16:44:39,763 - jwst.assign_wcs.util - INFO - Total of 100 grism objects defined
2025-09-13 16:44:39,787 - jwst.extract_2d.grisms - INFO - Grism object list created from source catalog: jw02079-o004_niriss_clear-f200w_cat.ecsv
2025-09-13 16:44:39,788 - jwst.extract_2d.grisms - INFO - Extracting 100 grism objects
2025-09-13 16:44:39,893 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 8 order: 1:
2025-09-13 16:44:39,894 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1843, xmax:1853), (ymin:0, ymax:9)
2025-09-13 16:44:40,064 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 522 order: 1:
2025-09-13 16:44:40,065 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:622, xmax:768), (ymin:433, ymax:702)
2025-09-13 16:44:40,250 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 796 order: 1:
2025-09-13 16:44:40,251 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1801, xmax:1895), (ymin:856, ymax:1074)
2025-09-13 16:44:40,430 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 1479 order: 1:
2025-09-13 16:44:40,430 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:151, xmax:253), (ymin:1890, ymax:2048)
2025-09-13 16:44:40,606 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 214 order: 1:
2025-09-13 16:44:40,607 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:316, xmax:400), (ymin:6, ymax:233)
2025-09-13 16:44:40,787 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 693 order: 1:
2025-09-13 16:44:40,787 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:99, xmax:169), (ymin:688, ymax:886)
2025-09-13 16:44:40,964 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 1120 order: 1:
2025-09-13 16:44:40,965 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:518, xmax:626), (ymin:1314, ymax:1506)
2025-09-13 16:44:41,574 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 1257 order: 1:
2025-09-13 16:44:41,574 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1457, xmax:1559), (ymin:1508, ymax:1708)
2025-09-13 16:44:41,749 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 766 order: 1:
2025-09-13 16:44:41,750 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:958, xmax:1010), (ymin:814, ymax:1040)
2025-09-13 16:44:41,921 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 606 order: 1:
2025-09-13 16:44:41,922 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:447, xmax:457), (ymin:549, ymax:735)
2025-09-13 16:44:42,092 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 649 order: 1:
2025-09-13 16:44:42,093 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1543, xmax:1632), (ymin:617, ymax:833)
2025-09-13 16:44:42,270 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 982 order: 1:
2025-09-13 16:44:42,271 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:406, xmax:455), (ymin:1112, ymax:1290)
2025-09-13 16:44:42,444 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 1364 order: 1:
2025-09-13 16:44:42,444 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1367, xmax:1411), (ymin:1682, ymax:1865)
2025-09-13 16:44:42,620 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 898 order: 1:
2025-09-13 16:44:42,620 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1423, xmax:1433), (ymin:999, ymax:1214)
2025-09-13 16:44:42,787 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 1049 order: 1:
2025-09-13 16:44:42,788 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:0, xmax:16), (ymin:1210, ymax:1409)
2025-09-13 16:44:42,958 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 732 order: 1:
2025-09-13 16:44:42,958 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:504, xmax:568), (ymin:757, ymax:924)
2025-09-13 16:44:43,126 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 189 order: 1:
2025-09-13 16:44:43,127 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1120, xmax:1168), (ymin:0, ymax:140)
2025-09-13 16:44:43,297 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 881 order: 1:
2025-09-13 16:44:43,298 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1155, xmax:1165), (ymin:969, ymax:1154)
2025-09-13 16:44:43,470 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 966 order: 1:
2025-09-13 16:44:43,470 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1391, xmax:1445), (ymin:1103, ymax:1285)
2025-09-13 16:44:43,643 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 914 order: 1:
2025-09-13 16:44:43,643 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1770, xmax:1812), (ymin:1023, ymax:1177)
2025-09-13 16:44:43,818 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 1084 order: 1:
2025-09-13 16:44:43,819 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1814, xmax:1824), (ymin:1275, ymax:1440)
2025-09-13 16:44:43,993 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 540 order: 1:
2025-09-13 16:44:43,994 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1685, xmax:1748), (ymin:459, ymax:652)
2025-09-13 16:44:44,169 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 1476 order: 1:
2025-09-13 16:44:44,170 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:0, xmax:40), (ymin:1889, ymax:2048)
2025-09-13 16:44:44,351 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 1142 order: 1:
2025-09-13 16:44:44,351 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:79, xmax:122), (ymin:1345, ymax:1514)
2025-09-13 16:44:44,531 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 220 order: 1:
2025-09-13 16:44:44,532 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:149, xmax:159), (ymin:16, ymax:189)
2025-09-13 16:44:44,708 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 289 order: 1:
2025-09-13 16:44:44,708 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1861, xmax:1909), (ymin:116, ymax:273)
2025-09-13 16:44:44,886 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 934 order: 1:
2025-09-13 16:44:44,887 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:685, xmax:734), (ymin:1049, ymax:1219)
2025-09-13 16:44:45,065 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 1219 order: 1:
2025-09-13 16:44:45,066 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:922, xmax:967), (ymin:1460, ymax:1643)
2025-09-13 16:44:45,243 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 927 order: 1:
2025-09-13 16:44:45,244 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:783, xmax:835), (ymin:1036, ymax:1203)
2025-09-13 16:44:45,418 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 1417 order: 1:
2025-09-13 16:44:45,419 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:134, xmax:173), (ymin:1778, ymax:1940)
2025-09-13 16:44:45,597 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 567 order: 1:
2025-09-13 16:44:45,598 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1649, xmax:1694), (ymin:507, ymax:677)
2025-09-13 16:44:45,778 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 1296 order: 1:
2025-09-13 16:44:45,779 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:628, xmax:669), (ymin:1562, ymax:1729)
2025-09-13 16:44:45,959 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 1412 order: 1:
2025-09-13 16:44:45,960 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:849, xmax:887), (ymin:1773, ymax:1936)
2025-09-13 16:44:46,138 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 654 order: 1:
2025-09-13 16:44:46,139 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1755, xmax:1821), (ymin:625, ymax:807)
2025-09-13 16:44:46,322 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 1029 order: 1:
2025-09-13 16:44:46,323 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:105, xmax:178), (ymin:1176, ymax:1355)
2025-09-13 16:44:46,501 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 553 order: 1:
2025-09-13 16:44:46,502 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:423, xmax:471), (ymin:475, ymax:633)
2025-09-13 16:44:47,228 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 1387 order: 1:
2025-09-13 16:44:47,229 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1977, xmax:2015), (ymin:1727, ymax:1891)
2025-09-13 16:44:47,399 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 422 order: 1:
2025-09-13 16:44:47,400 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1532, xmax:1564), (ymin:283, ymax:434)
2025-09-13 16:44:47,571 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 821 order: 1:
2025-09-13 16:44:47,571 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:99, xmax:135), (ymin:876, ymax:1042)
2025-09-13 16:44:47,747 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 682 order: 1:
2025-09-13 16:44:47,747 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:952, xmax:993), (ymin:681, ymax:853)
2025-09-13 16:44:47,924 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 1140 order: 1:
2025-09-13 16:44:47,925 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1614, xmax:1662), (ymin:1350, ymax:1516)
2025-09-13 16:44:48,101 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 1388 order: 1:
2025-09-13 16:44:48,102 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1750, xmax:1801), (ymin:1728, ymax:1910)
2025-09-13 16:44:48,280 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 759 order: 1:
2025-09-13 16:44:48,281 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1148, xmax:1193), (ymin:806, ymax:969)
2025-09-13 16:44:48,456 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 1407 order: 1:
2025-09-13 16:44:48,457 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1245, xmax:1286), (ymin:1757, ymax:1916)
2025-09-13 16:44:48,636 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 1194 order: 1:
2025-09-13 16:44:48,637 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1669, xmax:1711), (ymin:1412, ymax:1565)
2025-09-13 16:44:48,811 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 712 order: 1:
2025-09-13 16:44:48,811 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1285, xmax:1326), (ymin:726, ymax:883)
2025-09-13 16:44:48,991 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 539 order: 1:
2025-09-13 16:44:48,991 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1595, xmax:1623), (ymin:459, ymax:623)
2025-09-13 16:44:49,168 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 1008 order: 1:
2025-09-13 16:44:49,169 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1008, xmax:1040), (ymin:1154, ymax:1308)
2025-09-13 16:44:49,345 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 347 order: 1:
2025-09-13 16:44:49,346 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:697, xmax:707), (ymin:180, ymax:338)
2025-09-13 16:44:49,521 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 276 order: 1:
2025-09-13 16:44:49,522 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1279, xmax:1321), (ymin:93, ymax:259)
2025-09-13 16:44:49,699 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 605 order: 1:
2025-09-13 16:44:49,700 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:324, xmax:334), (ymin:548, ymax:694)
2025-09-13 16:44:49,876 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 922 order: 1:
2025-09-13 16:44:49,877 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1697, xmax:1727), (ymin:1032, ymax:1185)
2025-09-13 16:44:50,054 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 736 order: 1:
2025-09-13 16:44:50,055 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:2020, xmax:2042), (ymin:770, ymax:915)
2025-09-13 16:44:50,230 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 1423 order: 1:
2025-09-13 16:44:50,231 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:191, xmax:223), (ymin:1798, ymax:1954)
2025-09-13 16:44:50,406 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 800 order: 1:
2025-09-13 16:44:50,407 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:774, xmax:802), (ymin:856, ymax:1006)
2025-09-13 16:44:50,578 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 873 order: 1:
2025-09-13 16:44:50,579 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1986, xmax:2009), (ymin:963, ymax:1113)
2025-09-13 16:44:50,755 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 385 order: 1:
2025-09-13 16:44:50,755 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:410, xmax:451), (ymin:226, ymax:369)
2025-09-13 16:44:50,929 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 557 order: 1:
2025-09-13 16:44:50,930 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:309, xmax:347), (ymin:488, ymax:648)
2025-09-13 16:44:51,102 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 719 order: 1:
2025-09-13 16:44:51,103 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1571, xmax:1595), (ymin:737, ymax:889)
2025-09-13 16:44:51,277 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 389 order: 1:
2025-09-13 16:44:51,278 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:466, xmax:499), (ymin:230, ymax:382)
2025-09-13 16:44:51,454 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 733 order: 1:
2025-09-13 16:44:51,454 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1838, xmax:1892), (ymin:766, ymax:932)
2025-09-13 16:44:51,627 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 1442 order: 1:
2025-09-13 16:44:51,627 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:665, xmax:708), (ymin:1832, ymax:2000)
2025-09-13 16:44:51,799 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 417 order: 1:
2025-09-13 16:44:51,800 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:920, xmax:945), (ymin:271, ymax:422)
2025-09-13 16:44:51,972 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 630 order: 1:
2025-09-13 16:44:51,972 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1889, xmax:1899), (ymin:583, ymax:721)
2025-09-13 16:44:52,143 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 925 order: 1:
2025-09-13 16:44:52,144 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:403, xmax:446), (ymin:1029, ymax:1185)
2025-09-13 16:44:52,322 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 527 order: 1:
2025-09-13 16:44:52,323 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1877, xmax:1905), (ymin:445, ymax:602)
2025-09-13 16:44:52,499 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 439 order: 1:
2025-09-13 16:44:52,500 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:793, xmax:803), (ymin:302, ymax:458)
2025-09-13 16:44:53,311 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 1253 order: 1:
2025-09-13 16:44:53,312 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:234, xmax:257), (ymin:1499, ymax:1655)
2025-09-13 16:44:53,488 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 1162 order: 1:
2025-09-13 16:44:53,489 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:914, xmax:935), (ymin:1370, ymax:1513)
2025-09-13 16:44:53,667 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 1457 order: 1:
2025-09-13 16:44:53,668 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:270, xmax:293), (ymin:1858, ymax:2007)
2025-09-13 16:44:53,843 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 694 order: 1:
2025-09-13 16:44:53,843 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:351, xmax:395), (ymin:690, ymax:835)
2025-09-13 16:44:54,023 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 1266 order: 1:
2025-09-13 16:44:54,024 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:817, xmax:853), (ymin:1521, ymax:1671)
2025-09-13 16:44:54,204 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 298 order: 1:
2025-09-13 16:44:54,204 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1148, xmax:1181), (ymin:123, ymax:268)
2025-09-13 16:44:54,383 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 516 order: 1:
2025-09-13 16:44:54,384 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:581, xmax:611), (ymin:425, ymax:581)
2025-09-13 16:44:54,563 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 973 order: 1:
2025-09-13 16:44:54,564 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:558, xmax:580), (ymin:1105, ymax:1249)
2025-09-13 16:44:54,743 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 180 order: 1:
2025-09-13 16:44:54,744 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1477, xmax:1520), (ymin:0, ymax:115)
2025-09-13 16:44:54,924 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 980 order: 1:
2025-09-13 16:44:54,924 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1463, xmax:1502), (ymin:1116, ymax:1269)
2025-09-13 16:44:55,103 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 263 order: 1:
2025-09-13 16:44:55,103 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:934, xmax:972), (ymin:65, ymax:212)
2025-09-13 16:44:55,280 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 493 order: 1:
2025-09-13 16:44:55,281 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1515, xmax:1545), (ymin:390, ymax:542)
2025-09-13 16:44:55,459 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 981 order: 1:
2025-09-13 16:44:55,460 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1833, xmax:1852), (ymin:1118, ymax:1264)
2025-09-13 16:44:55,634 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 1371 order: 1:
2025-09-13 16:44:55,635 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:733, xmax:756), (ymin:1689, ymax:1836)
2025-09-13 16:44:55,811 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 536 order: 1:
2025-09-13 16:44:55,812 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:483, xmax:507), (ymin:449, ymax:605)
2025-09-13 16:44:55,984 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 749 order: 1:
2025-09-13 16:44:55,985 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1591, xmax:1616), (ymin:793, ymax:938)
2025-09-13 16:44:56,158 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 345 order: 1:
2025-09-13 16:44:56,159 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:957, xmax:978), (ymin:180, ymax:324)
2025-09-13 16:44:56,333 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 721 order: 1:
2025-09-13 16:44:56,334 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:230, xmax:240), (ymin:732, ymax:872)
2025-09-13 16:44:56,506 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 387 order: 1:
2025-09-13 16:44:56,507 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1490, xmax:1514), (ymin:232, ymax:374)
2025-09-13 16:44:56,681 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 505 order: 1:
2025-09-13 16:44:56,681 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1545, xmax:1567), (ymin:420, ymax:563)
2025-09-13 16:44:56,854 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 566 order: 1:
2025-09-13 16:44:56,854 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1220, xmax:1244), (ymin:505, ymax:664)
2025-09-13 16:44:57,026 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 772 order: 1:
2025-09-13 16:44:57,027 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1722, xmax:1747), (ymin:822, ymax:970)
2025-09-13 16:44:57,199 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 722 order: 1:
2025-09-13 16:44:57,199 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:498, xmax:529), (ymin:734, ymax:884)
2025-09-13 16:44:57,374 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 872 order: 1:
2025-09-13 16:44:57,375 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1533, xmax:1543), (ymin:961, ymax:1103)
2025-09-13 16:44:57,546 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 933 order: 1:
2025-09-13 16:44:57,547 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:135, xmax:171), (ymin:1046, ymax:1194)
2025-09-13 16:44:57,720 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 1128 order: 1:
2025-09-13 16:44:57,721 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1798, xmax:1808), (ymin:1333, ymax:1472)
2025-09-13 16:44:57,895 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 1282 order: 1:
2025-09-13 16:44:57,895 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:906, xmax:940), (ymin:1551, ymax:1710)
2025-09-13 16:44:58,071 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 274 order: 1:
2025-09-13 16:44:58,071 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:496, xmax:528), (ymin:82, ymax:236)
2025-09-13 16:44:58,246 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 641 order: 1:
2025-09-13 16:44:58,247 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1629, xmax:1658), (ymin:601, ymax:747)
2025-09-13 16:44:58,417 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 543 order: 1:
2025-09-13 16:44:58,418 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:238, xmax:269), (ymin:458, ymax:610)
2025-09-13 16:44:58,588 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 1188 order: 1:
2025-09-13 16:44:58,588 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:549, xmax:566), (ymin:1401, ymax:1562)
2025-09-13 16:44:58,762 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 533 order: 1:
2025-09-13 16:44:58,762 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1425, xmax:1450), (ymin:450, ymax:594)
2025-09-13 16:44:58,939 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 1342 order: 1:
2025-09-13 16:44:58,940 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1492, xmax:1513), (ymin:1645, ymax:1791)
2025-09-13 16:45:02,188 - jwst.extract_2d.grisms - INFO - Finished extractions
2025-09-13 16:45:02,222 - stpipe.Spec2Pipeline.extract_2d - INFO - Step extract_2d done
2025-09-13 16:45:02,794 - stpipe.Spec2Pipeline.srctype - INFO - Step srctype running with args (<MultiSlitModel from jw02079004003_03101_00001_nis_rate.fits>,).
2025-09-13 16:45:02,801 - jwst.srctype.srctype - INFO - Input EXP_TYPE is NIS_WFSS
2025-09-13 16:45:02,802 - jwst.srctype.srctype - INFO - source_id=8, type=POINT
2025-09-13 16:45:02,802 - jwst.srctype.srctype - INFO - source_id=522, type=EXTENDED
2025-09-13 16:45:02,803 - jwst.srctype.srctype - INFO - source_id=796, type=EXTENDED
2025-09-13 16:45:02,804 - jwst.srctype.srctype - INFO - source_id=1479, type=EXTENDED
2025-09-13 16:45:02,804 - jwst.srctype.srctype - INFO - source_id=214, type=EXTENDED
2025-09-13 16:45:02,805 - jwst.srctype.srctype - INFO - source_id=693, type=EXTENDED
2025-09-13 16:45:02,805 - jwst.srctype.srctype - INFO - source_id=1120, type=EXTENDED
2025-09-13 16:45:02,806 - jwst.srctype.srctype - INFO - source_id=1257, type=EXTENDED
2025-09-13 16:45:02,806 - jwst.srctype.srctype - INFO - source_id=766, type=EXTENDED
2025-09-13 16:45:02,807 - jwst.srctype.srctype - INFO - source_id=606, type=POINT
2025-09-13 16:45:02,808 - jwst.srctype.srctype - INFO - source_id=649, type=EXTENDED
2025-09-13 16:45:02,808 - jwst.srctype.srctype - INFO - source_id=982, type=EXTENDED
2025-09-13 16:45:02,809 - jwst.srctype.srctype - INFO - source_id=1364, type=EXTENDED
2025-09-13 16:45:02,809 - jwst.srctype.srctype - INFO - source_id=898, type=POINT
2025-09-13 16:45:02,810 - jwst.srctype.srctype - INFO - source_id=1049, type=EXTENDED
2025-09-13 16:45:02,811 - jwst.srctype.srctype - INFO - source_id=732, type=EXTENDED
2025-09-13 16:45:02,811 - jwst.srctype.srctype - INFO - source_id=189, type=EXTENDED
2025-09-13 16:45:02,812 - jwst.srctype.srctype - INFO - source_id=881, type=POINT
2025-09-13 16:45:02,812 - jwst.srctype.srctype - INFO - source_id=966, type=EXTENDED
2025-09-13 16:45:02,813 - jwst.srctype.srctype - INFO - source_id=914, type=EXTENDED
2025-09-13 16:45:02,813 - jwst.srctype.srctype - INFO - source_id=1084, type=POINT
2025-09-13 16:45:02,814 - jwst.srctype.srctype - INFO - source_id=540, type=EXTENDED
2025-09-13 16:45:02,815 - jwst.srctype.srctype - INFO - source_id=1476, type=EXTENDED
2025-09-13 16:45:02,815 - jwst.srctype.srctype - INFO - source_id=1142, type=EXTENDED
2025-09-13 16:45:02,816 - jwst.srctype.srctype - INFO - source_id=220, type=POINT
2025-09-13 16:45:02,816 - jwst.srctype.srctype - INFO - source_id=289, type=EXTENDED
2025-09-13 16:45:02,817 - jwst.srctype.srctype - INFO - source_id=934, type=EXTENDED
2025-09-13 16:45:02,817 - jwst.srctype.srctype - INFO - source_id=1219, type=EXTENDED
2025-09-13 16:45:02,818 - jwst.srctype.srctype - INFO - source_id=927, type=EXTENDED
2025-09-13 16:45:02,819 - jwst.srctype.srctype - INFO - source_id=1417, type=EXTENDED
2025-09-13 16:45:02,819 - jwst.srctype.srctype - INFO - source_id=567, type=EXTENDED
2025-09-13 16:45:02,820 - jwst.srctype.srctype - INFO - source_id=1296, type=EXTENDED
2025-09-13 16:45:02,820 - jwst.srctype.srctype - INFO - source_id=1412, type=EXTENDED
2025-09-13 16:45:02,821 - jwst.srctype.srctype - INFO - source_id=654, type=EXTENDED
2025-09-13 16:45:02,822 - jwst.srctype.srctype - INFO - source_id=1029, type=EXTENDED
2025-09-13 16:45:02,822 - jwst.srctype.srctype - INFO - source_id=553, type=EXTENDED
2025-09-13 16:45:02,823 - jwst.srctype.srctype - INFO - source_id=1387, type=EXTENDED
2025-09-13 16:45:02,823 - jwst.srctype.srctype - INFO - source_id=422, type=EXTENDED
2025-09-13 16:45:02,824 - jwst.srctype.srctype - INFO - source_id=821, type=EXTENDED
2025-09-13 16:45:02,824 - jwst.srctype.srctype - INFO - source_id=682, type=EXTENDED
2025-09-13 16:45:02,825 - jwst.srctype.srctype - INFO - source_id=1140, type=EXTENDED
2025-09-13 16:45:02,826 - jwst.srctype.srctype - INFO - source_id=1388, type=EXTENDED
2025-09-13 16:45:02,826 - jwst.srctype.srctype - INFO - source_id=759, type=EXTENDED
2025-09-13 16:45:02,827 - jwst.srctype.srctype - INFO - source_id=1407, type=EXTENDED
2025-09-13 16:45:02,827 - jwst.srctype.srctype - INFO - source_id=1194, type=EXTENDED
2025-09-13 16:45:02,828 - jwst.srctype.srctype - INFO - source_id=712, type=EXTENDED
2025-09-13 16:45:02,828 - jwst.srctype.srctype - INFO - source_id=539, type=EXTENDED
2025-09-13 16:45:02,829 - jwst.srctype.srctype - INFO - source_id=1008, type=EXTENDED
2025-09-13 16:45:02,829 - jwst.srctype.srctype - INFO - source_id=347, type=POINT
2025-09-13 16:45:02,830 - jwst.srctype.srctype - INFO - source_id=276, type=EXTENDED
2025-09-13 16:45:02,831 - jwst.srctype.srctype - INFO - source_id=605, type=POINT
2025-09-13 16:45:02,831 - jwst.srctype.srctype - INFO - source_id=922, type=EXTENDED
2025-09-13 16:45:02,832 - jwst.srctype.srctype - INFO - source_id=736, type=EXTENDED
2025-09-13 16:45:02,833 - jwst.srctype.srctype - INFO - source_id=1423, type=EXTENDED
2025-09-13 16:45:02,833 - jwst.srctype.srctype - INFO - source_id=800, type=EXTENDED
2025-09-13 16:45:02,834 - jwst.srctype.srctype - INFO - source_id=873, type=EXTENDED
2025-09-13 16:45:02,834 - jwst.srctype.srctype - INFO - source_id=385, type=EXTENDED
2025-09-13 16:45:02,835 - jwst.srctype.srctype - INFO - source_id=557, type=EXTENDED
2025-09-13 16:45:02,836 - jwst.srctype.srctype - INFO - source_id=719, type=EXTENDED
2025-09-13 16:45:02,836 - jwst.srctype.srctype - INFO - source_id=389, type=EXTENDED
2025-09-13 16:45:02,837 - jwst.srctype.srctype - INFO - source_id=733, type=EXTENDED
2025-09-13 16:45:02,837 - jwst.srctype.srctype - INFO - source_id=1442, type=EXTENDED
2025-09-13 16:45:02,838 - jwst.srctype.srctype - INFO - source_id=417, type=EXTENDED
2025-09-13 16:45:02,839 - jwst.srctype.srctype - INFO - source_id=630, type=POINT
2025-09-13 16:45:02,839 - jwst.srctype.srctype - INFO - source_id=925, type=EXTENDED
2025-09-13 16:45:02,840 - jwst.srctype.srctype - INFO - source_id=527, type=EXTENDED
2025-09-13 16:45:02,840 - jwst.srctype.srctype - INFO - source_id=439, type=POINT
2025-09-13 16:45:02,841 - jwst.srctype.srctype - INFO - source_id=1253, type=EXTENDED
2025-09-13 16:45:02,841 - jwst.srctype.srctype - INFO - source_id=1162, type=EXTENDED
2025-09-13 16:45:02,842 - jwst.srctype.srctype - INFO - source_id=1457, type=EXTENDED
2025-09-13 16:45:02,843 - jwst.srctype.srctype - INFO - source_id=694, type=EXTENDED
2025-09-13 16:45:02,843 - jwst.srctype.srctype - INFO - source_id=1266, type=EXTENDED
2025-09-13 16:45:02,844 - jwst.srctype.srctype - INFO - source_id=298, type=EXTENDED
2025-09-13 16:45:02,845 - jwst.srctype.srctype - INFO - source_id=516, type=EXTENDED
2025-09-13 16:45:02,845 - jwst.srctype.srctype - INFO - source_id=973, type=EXTENDED
2025-09-13 16:45:02,846 - jwst.srctype.srctype - INFO - source_id=180, type=EXTENDED
2025-09-13 16:45:02,846 - jwst.srctype.srctype - INFO - source_id=980, type=EXTENDED
2025-09-13 16:45:02,847 - jwst.srctype.srctype - INFO - source_id=263, type=EXTENDED
2025-09-13 16:45:02,847 - jwst.srctype.srctype - INFO - source_id=493, type=EXTENDED
2025-09-13 16:45:02,848 - jwst.srctype.srctype - INFO - source_id=981, type=EXTENDED
2025-09-13 16:45:02,848 - jwst.srctype.srctype - INFO - source_id=1371, type=EXTENDED
2025-09-13 16:45:02,849 - jwst.srctype.srctype - INFO - source_id=536, type=EXTENDED
2025-09-13 16:45:02,850 - jwst.srctype.srctype - INFO - source_id=749, type=EXTENDED
2025-09-13 16:45:02,850 - jwst.srctype.srctype - INFO - source_id=345, type=EXTENDED
2025-09-13 16:45:02,851 - jwst.srctype.srctype - INFO - source_id=721, type=POINT
2025-09-13 16:45:02,851 - jwst.srctype.srctype - INFO - source_id=387, type=EXTENDED
2025-09-13 16:45:02,852 - jwst.srctype.srctype - INFO - source_id=505, type=EXTENDED
2025-09-13 16:45:02,852 - jwst.srctype.srctype - INFO - source_id=566, type=EXTENDED
2025-09-13 16:45:02,853 - jwst.srctype.srctype - INFO - source_id=772, type=EXTENDED
2025-09-13 16:45:02,853 - jwst.srctype.srctype - INFO - source_id=722, type=EXTENDED
2025-09-13 16:45:02,854 - jwst.srctype.srctype - INFO - source_id=872, type=POINT
2025-09-13 16:45:02,855 - jwst.srctype.srctype - INFO - source_id=933, type=EXTENDED
2025-09-13 16:45:02,855 - jwst.srctype.srctype - INFO - source_id=1128, type=POINT
2025-09-13 16:45:02,856 - jwst.srctype.srctype - INFO - source_id=1282, type=EXTENDED
2025-09-13 16:45:02,857 - jwst.srctype.srctype - INFO - source_id=274, type=EXTENDED
2025-09-13 16:45:02,857 - jwst.srctype.srctype - INFO - source_id=641, type=EXTENDED
2025-09-13 16:45:02,858 - jwst.srctype.srctype - INFO - source_id=543, type=EXTENDED
2025-09-13 16:45:02,858 - jwst.srctype.srctype - INFO - source_id=1188, type=EXTENDED
2025-09-13 16:45:02,859 - jwst.srctype.srctype - INFO - source_id=533, type=EXTENDED
2025-09-13 16:45:02,859 - jwst.srctype.srctype - INFO - source_id=1342, type=EXTENDED
2025-09-13 16:45:02,862 - stpipe.Spec2Pipeline.srctype - INFO - Step srctype done
2025-09-13 16:45:03,449 - stpipe.Spec2Pipeline.straylight - INFO - Step straylight running with args (<MultiSlitModel from jw02079004003_03101_00001_nis_rate.fits>,).
2025-09-13 16:45:03,449 - stpipe.Spec2Pipeline.straylight - INFO - Step skipped.
2025-09-13 16:45:04,002 - stpipe.Spec2Pipeline.fringe - INFO - Step fringe running with args (<MultiSlitModel from jw02079004003_03101_00001_nis_rate.fits>,).
2025-09-13 16:45:04,003 - stpipe.Spec2Pipeline.fringe - INFO - Step skipped.
2025-09-13 16:45:04,535 - stpipe.Spec2Pipeline.pathloss - INFO - Step pathloss running with args (<MultiSlitModel from jw02079004003_03101_00001_nis_rate.fits>,).
2025-09-13 16:45:04,536 - stpipe.Spec2Pipeline.pathloss - INFO - Step skipped.
2025-09-13 16:45:05,085 - stpipe.Spec2Pipeline.barshadow - INFO - Step barshadow running with args (<MultiSlitModel from jw02079004003_03101_00001_nis_rate.fits>,).
2025-09-13 16:45:05,085 - stpipe.Spec2Pipeline.barshadow - INFO - Step skipped.
2025-09-13 16:45:05,628 - stpipe.Spec2Pipeline.wfss_contam - INFO - Step wfss_contam running with args (<MultiSlitModel from jw02079004003_03101_00001_nis_rate.fits>,).
2025-09-13 16:45:05,629 - stpipe.Spec2Pipeline.wfss_contam - INFO - Step skipped.
2025-09-13 16:45:06,153 - stpipe.Spec2Pipeline.photom - INFO - Step photom running with args (<MultiSlitModel from jw02079004003_03101_00001_nis_rate.fits>,).
2025-09-13 16:45:06,203 - stpipe.Spec2Pipeline.photom - INFO - Using photom reference file: /home/runner/crds/references/jwst/niriss/jwst_niriss_photom_0041.fits
2025-09-13 16:45:06,204 - stpipe.Spec2Pipeline.photom - INFO - Using area reference file: N/A
2025-09-13 16:45:09,286 - jwst.photom.photom - INFO - Using instrument: NIRISS
2025-09-13 16:45:09,287 - jwst.photom.photom - INFO - detector: NIS
2025-09-13 16:45:09,287 - jwst.photom.photom - INFO - exp_type: NIS_WFSS
2025-09-13 16:45:09,288 - jwst.photom.photom - INFO - filter: GR150R
2025-09-13 16:45:09,288 - jwst.photom.photom - INFO - pupil: F200W
2025-09-13 16:45:09,308 - jwst.photom.photom - INFO - Attempting to obtain PIXAR_SR and PIXAR_A2 values from PHOTOM reference file.
2025-09-13 16:45:09,308 - jwst.photom.photom - INFO - Values for PIXAR_SR and PIXAR_A2 obtained from PHOTOM reference file.
2025-09-13 16:45:09,343 - jwst.photom.photom - INFO - Working on slit 8, order 1
2025-09-13 16:45:09,344 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:45:09,347 - jwst.photom.photom - INFO - Working on slit 522, order 1
2025-09-13 16:45:09,348 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:45:09,353 - jwst.photom.photom - INFO - Working on slit 796, order 1
2025-09-13 16:45:09,354 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:45:09,358 - jwst.photom.photom - INFO - Working on slit 1479, order 1
2025-09-13 16:45:09,358 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:45:09,362 - jwst.photom.photom - INFO - Working on slit 214, order 1
2025-09-13 16:45:09,363 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:45:09,367 - jwst.photom.photom - INFO - Working on slit 693, order 1
2025-09-13 16:45:09,368 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:45:09,372 - jwst.photom.photom - INFO - Working on slit 1120, order 1
2025-09-13 16:45:09,372 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:45:09,376 - jwst.photom.photom - INFO - Working on slit 1257, order 1
2025-09-13 16:45:09,377 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:45:09,381 - jwst.photom.photom - INFO - Working on slit 766, order 1
2025-09-13 16:45:09,382 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:45:09,385 - jwst.photom.photom - INFO - Working on slit 606, order 1
2025-09-13 16:45:09,386 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:45:09,390 - jwst.photom.photom - INFO - Working on slit 649, order 1
2025-09-13 16:45:09,390 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:45:09,394 - jwst.photom.photom - INFO - Working on slit 982, order 1
2025-09-13 16:45:09,395 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:45:09,398 - jwst.photom.photom - INFO - Working on slit 1364, order 1
2025-09-13 16:45:09,399 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:45:09,403 - jwst.photom.photom - INFO - Working on slit 898, order 1
2025-09-13 16:45:09,403 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:45:09,407 - jwst.photom.photom - INFO - Working on slit 1049, order 1
2025-09-13 16:45:09,407 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:45:09,411 - jwst.photom.photom - INFO - Working on slit 732, order 1
2025-09-13 16:45:09,412 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:45:09,415 - jwst.photom.photom - INFO - Working on slit 189, order 1
2025-09-13 16:45:09,416 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:45:09,420 - jwst.photom.photom - INFO - Working on slit 881, order 1
2025-09-13 16:45:09,420 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:45:09,424 - jwst.photom.photom - INFO - Working on slit 966, order 1
2025-09-13 16:45:09,424 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:45:09,428 - jwst.photom.photom - INFO - Working on slit 914, order 1
2025-09-13 16:45:09,429 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:45:09,432 - jwst.photom.photom - INFO - Working on slit 1084, order 1
2025-09-13 16:45:09,433 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:45:09,436 - jwst.photom.photom - INFO - Working on slit 540, order 1
2025-09-13 16:45:09,437 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:45:09,441 - jwst.photom.photom - INFO - Working on slit 1476, order 1
2025-09-13 16:45:09,441 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:45:09,445 - jwst.photom.photom - INFO - Working on slit 1142, order 1
2025-09-13 16:45:09,446 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:45:09,449 - jwst.photom.photom - INFO - Working on slit 220, order 1
2025-09-13 16:45:09,450 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:45:09,453 - jwst.photom.photom - INFO - Working on slit 289, order 1
2025-09-13 16:45:09,454 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:45:09,457 - jwst.photom.photom - INFO - Working on slit 934, order 1
2025-09-13 16:45:09,458 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:45:09,461 - jwst.photom.photom - INFO - Working on slit 1219, order 1
2025-09-13 16:45:09,462 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:45:09,466 - jwst.photom.photom - INFO - Working on slit 927, order 1
2025-09-13 16:45:09,466 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:45:09,470 - jwst.photom.photom - INFO - Working on slit 1417, order 1
2025-09-13 16:45:09,471 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:45:09,475 - jwst.photom.photom - INFO - Working on slit 567, order 1
2025-09-13 16:45:09,475 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:45:09,479 - jwst.photom.photom - INFO - Working on slit 1296, order 1
2025-09-13 16:45:09,479 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:45:09,483 - jwst.photom.photom - INFO - Working on slit 1412, order 1
2025-09-13 16:45:09,484 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:45:09,487 - jwst.photom.photom - INFO - Working on slit 654, order 1
2025-09-13 16:45:09,488 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:45:09,492 - jwst.photom.photom - INFO - Working on slit 1029, order 1
2025-09-13 16:45:09,492 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:45:09,496 - jwst.photom.photom - INFO - Working on slit 553, order 1
2025-09-13 16:45:09,497 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:45:09,500 - jwst.photom.photom - INFO - Working on slit 1387, order 1
2025-09-13 16:45:09,501 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:45:09,505 - jwst.photom.photom - INFO - Working on slit 422, order 1
2025-09-13 16:45:09,505 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:45:09,509 - jwst.photom.photom - INFO - Working on slit 821, order 1
2025-09-13 16:45:09,510 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:45:09,513 - jwst.photom.photom - INFO - Working on slit 682, order 1
2025-09-13 16:45:09,514 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:45:09,517 - jwst.photom.photom - INFO - Working on slit 1140, order 1
2025-09-13 16:45:09,518 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:45:09,521 - jwst.photom.photom - INFO - Working on slit 1388, order 1
2025-09-13 16:45:09,522 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:45:09,525 - jwst.photom.photom - INFO - Working on slit 759, order 1
2025-09-13 16:45:09,526 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:45:09,530 - jwst.photom.photom - INFO - Working on slit 1407, order 1
2025-09-13 16:45:09,530 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:45:09,534 - jwst.photom.photom - INFO - Working on slit 1194, order 1
2025-09-13 16:45:09,534 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:45:09,538 - jwst.photom.photom - INFO - Working on slit 712, order 1
2025-09-13 16:45:09,539 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:45:09,542 - jwst.photom.photom - INFO - Working on slit 539, order 1
2025-09-13 16:45:09,543 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:45:09,547 - jwst.photom.photom - INFO - Working on slit 1008, order 1
2025-09-13 16:45:09,547 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:45:09,551 - jwst.photom.photom - INFO - Working on slit 347, order 1
2025-09-13 16:45:09,551 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:45:09,555 - jwst.photom.photom - INFO - Working on slit 276, order 1
2025-09-13 16:45:09,556 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:45:09,559 - jwst.photom.photom - INFO - Working on slit 605, order 1
2025-09-13 16:45:09,560 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:45:09,563 - jwst.photom.photom - INFO - Working on slit 922, order 1
2025-09-13 16:45:09,564 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:45:09,567 - jwst.photom.photom - INFO - Working on slit 736, order 1
2025-09-13 16:45:09,568 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:45:09,572 - jwst.photom.photom - INFO - Working on slit 1423, order 1
2025-09-13 16:45:09,572 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:45:09,576 - jwst.photom.photom - INFO - Working on slit 800, order 1
2025-09-13 16:45:09,576 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:45:09,579 - jwst.photom.photom - INFO - Working on slit 873, order 1
2025-09-13 16:45:09,580 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:45:09,584 - jwst.photom.photom - INFO - Working on slit 385, order 1
2025-09-13 16:45:09,584 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:45:09,588 - jwst.photom.photom - INFO - Working on slit 557, order 1
2025-09-13 16:45:09,588 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:45:09,592 - jwst.photom.photom - INFO - Working on slit 719, order 1
2025-09-13 16:45:09,593 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:45:09,596 - jwst.photom.photom - INFO - Working on slit 389, order 1
2025-09-13 16:45:09,597 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:45:09,600 - jwst.photom.photom - INFO - Working on slit 733, order 1
2025-09-13 16:45:09,601 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:45:09,604 - jwst.photom.photom - INFO - Working on slit 1442, order 1
2025-09-13 16:45:09,605 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:45:09,609 - jwst.photom.photom - INFO - Working on slit 417, order 1
2025-09-13 16:45:09,609 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:45:09,613 - jwst.photom.photom - INFO - Working on slit 630, order 1
2025-09-13 16:45:09,613 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:45:09,617 - jwst.photom.photom - INFO - Working on slit 925, order 1
2025-09-13 16:45:09,618 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:45:09,621 - jwst.photom.photom - INFO - Working on slit 527, order 1
2025-09-13 16:45:09,622 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:45:09,625 - jwst.photom.photom - INFO - Working on slit 439, order 1
2025-09-13 16:45:09,626 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:45:09,629 - jwst.photom.photom - INFO - Working on slit 1253, order 1
2025-09-13 16:45:09,630 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:45:09,633 - jwst.photom.photom - INFO - Working on slit 1162, order 1
2025-09-13 16:45:09,634 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:45:09,637 - jwst.photom.photom - INFO - Working on slit 1457, order 1
2025-09-13 16:45:09,638 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:45:09,641 - jwst.photom.photom - INFO - Working on slit 694, order 1
2025-09-13 16:45:09,642 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:45:09,646 - jwst.photom.photom - INFO - Working on slit 1266, order 1
2025-09-13 16:45:09,646 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:45:09,650 - jwst.photom.photom - INFO - Working on slit 298, order 1
2025-09-13 16:45:09,650 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:45:09,654 - jwst.photom.photom - INFO - Working on slit 516, order 1
2025-09-13 16:45:09,655 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:45:09,658 - jwst.photom.photom - INFO - Working on slit 973, order 1
2025-09-13 16:45:09,659 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:45:09,662 - jwst.photom.photom - INFO - Working on slit 180, order 1
2025-09-13 16:45:09,663 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:45:09,666 - jwst.photom.photom - INFO - Working on slit 980, order 1
2025-09-13 16:45:09,667 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:45:09,671 - jwst.photom.photom - INFO - Working on slit 263, order 1
2025-09-13 16:45:09,671 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:45:09,675 - jwst.photom.photom - INFO - Working on slit 493, order 1
2025-09-13 16:45:09,675 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:45:09,678 - jwst.photom.photom - INFO - Working on slit 981, order 1
2025-09-13 16:45:09,679 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:45:09,683 - jwst.photom.photom - INFO - Working on slit 1371, order 1
2025-09-13 16:45:09,683 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:45:09,687 - jwst.photom.photom - INFO - Working on slit 536, order 1
2025-09-13 16:45:09,687 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:45:09,691 - jwst.photom.photom - INFO - Working on slit 749, order 1
2025-09-13 16:45:09,692 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:45:09,695 - jwst.photom.photom - INFO - Working on slit 345, order 1
2025-09-13 16:45:09,695 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:45:09,699 - jwst.photom.photom - INFO - Working on slit 721, order 1
2025-09-13 16:45:09,700 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:45:09,703 - jwst.photom.photom - INFO - Working on slit 387, order 1
2025-09-13 16:45:09,704 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:45:09,707 - jwst.photom.photom - INFO - Working on slit 505, order 1
2025-09-13 16:45:09,708 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:45:09,711 - jwst.photom.photom - INFO - Working on slit 566, order 1
2025-09-13 16:45:09,712 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:45:09,716 - jwst.photom.photom - INFO - Working on slit 772, order 1
2025-09-13 16:45:09,716 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:45:09,720 - jwst.photom.photom - INFO - Working on slit 722, order 1
2025-09-13 16:45:09,720 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:45:09,724 - jwst.photom.photom - INFO - Working on slit 872, order 1
2025-09-13 16:45:09,725 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:45:09,728 - jwst.photom.photom - INFO - Working on slit 933, order 1
2025-09-13 16:45:09,729 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:45:09,732 - jwst.photom.photom - INFO - Working on slit 1128, order 1
2025-09-13 16:45:09,732 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:45:09,736 - jwst.photom.photom - INFO - Working on slit 1282, order 1
2025-09-13 16:45:09,737 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:45:09,740 - jwst.photom.photom - INFO - Working on slit 274, order 1
2025-09-13 16:45:09,741 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:45:09,745 - jwst.photom.photom - INFO - Working on slit 641, order 1
2025-09-13 16:45:09,745 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:45:09,749 - jwst.photom.photom - INFO - Working on slit 543, order 1
2025-09-13 16:45:09,749 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:45:09,753 - jwst.photom.photom - INFO - Working on slit 1188, order 1
2025-09-13 16:45:09,754 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:45:09,757 - jwst.photom.photom - INFO - Working on slit 533, order 1
2025-09-13 16:45:09,758 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:45:09,762 - jwst.photom.photom - INFO - Working on slit 1342, order 1
2025-09-13 16:45:09,762 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:45:09,770 - stpipe.Spec2Pipeline.photom - INFO - Step photom done
2025-09-13 16:45:12,986 - stpipe.Spec2Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<MultiSlitModel from /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage2_spec/jw02079004003_03101_00001_nis_cal.fits>,).
2025-09-13 16:45:12,987 - stpipe.Spec2Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 16:45:16,055 - stpipe.Spec2Pipeline.extract_1d - INFO - Step extract_1d running with args (<MultiSlitModel from /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage2_spec/jw02079004003_03101_00001_nis_cal.fits>,).
2025-09-13 16:45:16,179 - stpipe.Spec2Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 16:45:16,229 - jwst.extract_1d.extract - INFO - Working on slit 8
2025-09-13 16:45:16,230 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type POINT
2025-09-13 16:45:16,231 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 10.00 (inclusive)
2025-09-13 16:45:16,238 - jwst.extract_1d.extract - INFO - Creating aperture correction.
2025-09-13 16:45:16,294 - jwst.extract_1d.extract - INFO - Working on slit 522
2025-09-13 16:45:16,296 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:45:16,297 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 146.00 (inclusive)
2025-09-13 16:45:16,351 - jwst.extract_1d.extract - INFO - Working on slit 796
2025-09-13 16:45:16,353 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:45:16,354 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 94.00 (inclusive)
2025-09-13 16:45:16,407 - jwst.extract_1d.extract - INFO - Working on slit 1479
2025-09-13 16:45:16,408 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:45:16,409 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 102.00 (inclusive)
2025-09-13 16:45:16,463 - jwst.extract_1d.extract - INFO - Working on slit 214
2025-09-13 16:45:16,464 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:45:16,465 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 84.00 (inclusive)
2025-09-13 16:45:16,519 - jwst.extract_1d.extract - INFO - Working on slit 693
2025-09-13 16:45:16,520 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:45:16,521 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 70.00 (inclusive)
2025-09-13 16:45:16,575 - jwst.extract_1d.extract - INFO - Working on slit 1120
2025-09-13 16:45:16,576 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:45:16,577 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 108.00 (inclusive)
2025-09-13 16:45:16,631 - jwst.extract_1d.extract - INFO - Working on slit 1257
2025-09-13 16:45:16,633 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:45:16,634 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 102.00 (inclusive)
2025-09-13 16:45:16,687 - jwst.extract_1d.extract - INFO - Working on slit 766
2025-09-13 16:45:16,688 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:45:16,689 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 52.00 (inclusive)
2025-09-13 16:45:16,743 - jwst.extract_1d.extract - INFO - Working on slit 606
2025-09-13 16:45:16,744 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type POINT
2025-09-13 16:45:16,744 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 10.00 (inclusive)
2025-09-13 16:45:16,751 - jwst.extract_1d.extract - INFO - Creating aperture correction.
2025-09-13 16:45:16,890 - jwst.extract_1d.extract - INFO - Working on slit 649
2025-09-13 16:45:16,891 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:45:16,892 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 89.00 (inclusive)
2025-09-13 16:45:16,947 - jwst.extract_1d.extract - INFO - Working on slit 982
2025-09-13 16:45:16,948 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:45:16,949 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 49.00 (inclusive)
2025-09-13 16:45:17,004 - jwst.extract_1d.extract - INFO - Working on slit 1364
2025-09-13 16:45:17,005 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:45:17,006 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 44.00 (inclusive)
2025-09-13 16:45:17,061 - jwst.extract_1d.extract - INFO - Working on slit 898
2025-09-13 16:45:17,062 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type POINT
2025-09-13 16:45:17,063 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 10.00 (inclusive)
2025-09-13 16:45:17,070 - jwst.extract_1d.extract - INFO - Creating aperture correction.
2025-09-13 16:45:17,221 - jwst.extract_1d.extract - INFO - Working on slit 1049
2025-09-13 16:45:17,222 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:45:17,223 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 16.00 (inclusive)
2025-09-13 16:45:17,278 - jwst.extract_1d.extract - INFO - Working on slit 732
2025-09-13 16:45:17,279 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:45:17,280 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 64.00 (inclusive)
2025-09-13 16:45:17,336 - jwst.extract_1d.extract - INFO - Working on slit 189
2025-09-13 16:45:17,337 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:45:17,338 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 48.00 (inclusive)
2025-09-13 16:45:17,394 - jwst.extract_1d.extract - INFO - Working on slit 881
2025-09-13 16:45:17,395 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type POINT
2025-09-13 16:45:17,395 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 10.00 (inclusive)
2025-09-13 16:45:17,402 - jwst.extract_1d.extract - INFO - Creating aperture correction.
2025-09-13 16:45:17,538 - jwst.extract_1d.extract - INFO - Working on slit 966
2025-09-13 16:45:17,539 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:45:17,540 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 54.00 (inclusive)
2025-09-13 16:45:17,596 - jwst.extract_1d.extract - INFO - Working on slit 914
2025-09-13 16:45:17,597 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:45:17,598 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 42.00 (inclusive)
2025-09-13 16:45:17,652 - jwst.extract_1d.extract - INFO - Working on slit 1084
2025-09-13 16:45:17,653 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type POINT
2025-09-13 16:45:17,654 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 10.00 (inclusive)
2025-09-13 16:45:17,661 - jwst.extract_1d.extract - INFO - Creating aperture correction.
2025-09-13 16:45:17,791 - jwst.extract_1d.extract - INFO - Working on slit 540
2025-09-13 16:45:17,792 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:45:17,793 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 63.00 (inclusive)
2025-09-13 16:45:17,849 - jwst.extract_1d.extract - INFO - Working on slit 1476
2025-09-13 16:45:17,850 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:45:17,851 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 40.00 (inclusive)
2025-09-13 16:45:17,906 - jwst.extract_1d.extract - INFO - Working on slit 1142
2025-09-13 16:45:17,907 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:45:17,908 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 43.00 (inclusive)
2025-09-13 16:45:17,962 - jwst.extract_1d.extract - INFO - Working on slit 220
2025-09-13 16:45:17,963 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type POINT
2025-09-13 16:45:17,964 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 10.00 (inclusive)
2025-09-13 16:45:17,970 - jwst.extract_1d.extract - INFO - Creating aperture correction.
2025-09-13 16:45:18,104 - jwst.extract_1d.extract - INFO - Working on slit 289
2025-09-13 16:45:18,105 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:45:18,106 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 48.00 (inclusive)
2025-09-13 16:45:18,161 - jwst.extract_1d.extract - INFO - Working on slit 934
2025-09-13 16:45:18,162 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:45:18,163 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 49.00 (inclusive)
2025-09-13 16:45:18,218 - jwst.extract_1d.extract - INFO - Working on slit 1219
2025-09-13 16:45:18,219 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:45:18,220 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 45.00 (inclusive)
2025-09-13 16:45:18,275 - jwst.extract_1d.extract - INFO - Working on slit 927
2025-09-13 16:45:18,276 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:45:18,277 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 52.00 (inclusive)
2025-09-13 16:45:18,332 - jwst.extract_1d.extract - INFO - Working on slit 1417
2025-09-13 16:45:18,333 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:45:18,334 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 39.00 (inclusive)
2025-09-13 16:45:18,390 - jwst.extract_1d.extract - INFO - Working on slit 567
2025-09-13 16:45:18,391 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:45:18,392 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 45.00 (inclusive)
2025-09-13 16:45:18,447 - jwst.extract_1d.extract - INFO - Working on slit 1296
2025-09-13 16:45:18,448 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:45:18,449 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 41.00 (inclusive)
2025-09-13 16:45:18,503 - jwst.extract_1d.extract - INFO - Working on slit 1412
2025-09-13 16:45:18,504 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:45:18,505 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 38.00 (inclusive)
2025-09-13 16:45:18,557 - jwst.extract_1d.extract - INFO - Working on slit 654
2025-09-13 16:45:18,559 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:45:18,560 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 66.00 (inclusive)
2025-09-13 16:45:18,613 - jwst.extract_1d.extract - INFO - Working on slit 1029
2025-09-13 16:45:18,614 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:45:18,615 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 73.00 (inclusive)
2025-09-13 16:45:18,669 - jwst.extract_1d.extract - INFO - Working on slit 553
2025-09-13 16:45:18,670 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:45:18,671 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 48.00 (inclusive)
2025-09-13 16:45:18,724 - jwst.extract_1d.extract - INFO - Working on slit 1387
2025-09-13 16:45:18,725 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:45:18,726 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 38.00 (inclusive)
2025-09-13 16:45:18,779 - jwst.extract_1d.extract - INFO - Working on slit 422
2025-09-13 16:45:18,780 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:45:18,781 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 32.00 (inclusive)
2025-09-13 16:45:18,834 - jwst.extract_1d.extract - INFO - Working on slit 821
2025-09-13 16:45:18,836 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:45:18,837 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 36.00 (inclusive)
2025-09-13 16:45:18,890 - jwst.extract_1d.extract - INFO - Working on slit 682
2025-09-13 16:45:18,892 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:45:18,893 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 41.00 (inclusive)
2025-09-13 16:45:18,947 - jwst.extract_1d.extract - INFO - Working on slit 1140
2025-09-13 16:45:18,948 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:45:18,949 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 48.00 (inclusive)
2025-09-13 16:45:19,002 - jwst.extract_1d.extract - INFO - Working on slit 1388
2025-09-13 16:45:19,003 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:45:19,004 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 51.00 (inclusive)
2025-09-13 16:45:19,057 - jwst.extract_1d.extract - INFO - Working on slit 759
2025-09-13 16:45:19,059 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:45:19,059 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 45.00 (inclusive)
2025-09-13 16:45:19,113 - jwst.extract_1d.extract - INFO - Working on slit 1407
2025-09-13 16:45:19,115 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:45:19,115 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 41.00 (inclusive)
2025-09-13 16:45:19,170 - jwst.extract_1d.extract - INFO - Working on slit 1194
2025-09-13 16:45:19,171 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:45:19,172 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 42.00 (inclusive)
2025-09-13 16:45:19,225 - jwst.extract_1d.extract - INFO - Working on slit 712
2025-09-13 16:45:19,226 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:45:19,227 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 41.00 (inclusive)
2025-09-13 16:45:19,280 - jwst.extract_1d.extract - INFO - Working on slit 539
2025-09-13 16:45:19,281 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:45:19,282 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 28.00 (inclusive)
2025-09-13 16:45:19,334 - jwst.extract_1d.extract - INFO - Working on slit 1008
2025-09-13 16:45:19,335 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:45:19,336 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 32.00 (inclusive)
2025-09-13 16:45:19,389 - jwst.extract_1d.extract - INFO - Working on slit 347
2025-09-13 16:45:19,390 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type POINT
2025-09-13 16:45:19,390 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 10.00 (inclusive)
2025-09-13 16:45:19,397 - jwst.extract_1d.extract - INFO - Creating aperture correction.
2025-09-13 16:45:19,522 - jwst.extract_1d.extract - INFO - Working on slit 276
2025-09-13 16:45:19,523 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:45:19,524 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 42.00 (inclusive)
2025-09-13 16:45:19,575 - jwst.extract_1d.extract - INFO - Working on slit 605
2025-09-13 16:45:19,576 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type POINT
2025-09-13 16:45:19,577 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 10.00 (inclusive)
2025-09-13 16:45:19,584 - jwst.extract_1d.extract - INFO - Creating aperture correction.
2025-09-13 16:45:19,701 - jwst.extract_1d.extract - INFO - Working on slit 922
2025-09-13 16:45:19,702 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:45:19,703 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 30.00 (inclusive)
2025-09-13 16:45:19,755 - jwst.extract_1d.extract - INFO - Working on slit 736
2025-09-13 16:45:19,756 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:45:19,757 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 22.00 (inclusive)
2025-09-13 16:45:19,807 - jwst.extract_1d.extract - INFO - Working on slit 1423
2025-09-13 16:45:19,809 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:45:19,809 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 32.00 (inclusive)
2025-09-13 16:45:19,860 - jwst.extract_1d.extract - INFO - Working on slit 800
2025-09-13 16:45:19,861 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:45:19,861 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 28.00 (inclusive)
2025-09-13 16:45:19,912 - jwst.extract_1d.extract - INFO - Working on slit 873
2025-09-13 16:45:19,912 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:45:19,913 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 23.00 (inclusive)
2025-09-13 16:45:19,963 - jwst.extract_1d.extract - INFO - Working on slit 385
2025-09-13 16:45:19,964 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:45:19,965 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 41.00 (inclusive)
2025-09-13 16:45:20,016 - jwst.extract_1d.extract - INFO - Working on slit 557
2025-09-13 16:45:20,017 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:45:20,017 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 38.00 (inclusive)
2025-09-13 16:45:20,068 - jwst.extract_1d.extract - INFO - Working on slit 719
2025-09-13 16:45:20,069 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:45:20,069 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 24.00 (inclusive)
2025-09-13 16:45:20,120 - jwst.extract_1d.extract - INFO - Working on slit 389
2025-09-13 16:45:20,121 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:45:20,122 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 33.00 (inclusive)
2025-09-13 16:45:20,173 - jwst.extract_1d.extract - INFO - Working on slit 733
2025-09-13 16:45:20,174 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:45:20,175 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 54.00 (inclusive)
2025-09-13 16:45:20,227 - jwst.extract_1d.extract - INFO - Working on slit 1442
2025-09-13 16:45:20,228 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:45:20,229 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 43.00 (inclusive)
2025-09-13 16:45:20,281 - jwst.extract_1d.extract - INFO - Working on slit 417
2025-09-13 16:45:20,282 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:45:20,283 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 25.00 (inclusive)
2025-09-13 16:45:20,334 - jwst.extract_1d.extract - INFO - Working on slit 630
2025-09-13 16:45:20,335 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type POINT
2025-09-13 16:45:20,336 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 10.00 (inclusive)
2025-09-13 16:45:20,342 - jwst.extract_1d.extract - INFO - Creating aperture correction.
2025-09-13 16:45:20,456 - jwst.extract_1d.extract - INFO - Working on slit 925
2025-09-13 16:45:20,457 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:45:20,458 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 43.00 (inclusive)
2025-09-13 16:45:20,510 - jwst.extract_1d.extract - INFO - Working on slit 527
2025-09-13 16:45:20,512 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:45:20,512 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 28.00 (inclusive)
2025-09-13 16:45:20,564 - jwst.extract_1d.extract - INFO - Working on slit 439
2025-09-13 16:45:20,565 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type POINT
2025-09-13 16:45:20,566 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 10.00 (inclusive)
2025-09-13 16:45:20,573 - jwst.extract_1d.extract - INFO - Creating aperture correction.
2025-09-13 16:45:20,695 - jwst.extract_1d.extract - INFO - Working on slit 1253
2025-09-13 16:45:20,696 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:45:20,697 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 23.00 (inclusive)
2025-09-13 16:45:20,749 - jwst.extract_1d.extract - INFO - Working on slit 1162
2025-09-13 16:45:20,750 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:45:20,751 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 21.00 (inclusive)
2025-09-13 16:45:20,803 - jwst.extract_1d.extract - INFO - Working on slit 1457
2025-09-13 16:45:20,804 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:45:20,805 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 23.00 (inclusive)
2025-09-13 16:45:20,858 - jwst.extract_1d.extract - INFO - Working on slit 694
2025-09-13 16:45:20,859 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:45:20,860 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 44.00 (inclusive)
2025-09-13 16:45:20,912 - jwst.extract_1d.extract - INFO - Working on slit 1266
2025-09-13 16:45:20,913 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:45:20,914 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 36.00 (inclusive)
2025-09-13 16:45:20,965 - jwst.extract_1d.extract - INFO - Working on slit 298
2025-09-13 16:45:20,966 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:45:20,967 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 33.00 (inclusive)
2025-09-13 16:45:21,019 - jwst.extract_1d.extract - INFO - Working on slit 516
2025-09-13 16:45:21,020 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:45:21,020 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 30.00 (inclusive)
2025-09-13 16:45:21,073 - jwst.extract_1d.extract - INFO - Working on slit 973
2025-09-13 16:45:21,074 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:45:21,074 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 22.00 (inclusive)
2025-09-13 16:45:21,127 - jwst.extract_1d.extract - INFO - Working on slit 180
2025-09-13 16:45:21,128 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:45:21,129 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 43.00 (inclusive)
2025-09-13 16:45:21,183 - jwst.extract_1d.extract - INFO - Working on slit 980
2025-09-13 16:45:21,184 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:45:21,185 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 39.00 (inclusive)
2025-09-13 16:45:21,237 - jwst.extract_1d.extract - INFO - Working on slit 263
2025-09-13 16:45:21,238 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:45:21,239 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 38.00 (inclusive)
2025-09-13 16:45:21,291 - jwst.extract_1d.extract - INFO - Working on slit 493
2025-09-13 16:45:21,292 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:45:21,293 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 30.00 (inclusive)
2025-09-13 16:45:21,345 - jwst.extract_1d.extract - INFO - Working on slit 981
2025-09-13 16:45:21,346 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:45:21,347 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 19.00 (inclusive)
2025-09-13 16:45:21,399 - jwst.extract_1d.extract - INFO - Working on slit 1371
2025-09-13 16:45:21,400 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:45:21,401 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 23.00 (inclusive)
2025-09-13 16:45:21,453 - jwst.extract_1d.extract - INFO - Working on slit 536
2025-09-13 16:45:21,454 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:45:21,455 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 24.00 (inclusive)
2025-09-13 16:45:21,508 - jwst.extract_1d.extract - INFO - Working on slit 749
2025-09-13 16:45:21,509 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:45:21,510 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 25.00 (inclusive)
2025-09-13 16:45:21,562 - jwst.extract_1d.extract - INFO - Working on slit 345
2025-09-13 16:45:21,563 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:45:21,564 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 21.00 (inclusive)
2025-09-13 16:45:21,617 - jwst.extract_1d.extract - INFO - Working on slit 721
2025-09-13 16:45:21,618 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type POINT
2025-09-13 16:45:21,619 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 10.00 (inclusive)
2025-09-13 16:45:21,625 - jwst.extract_1d.extract - INFO - Creating aperture correction.
2025-09-13 16:45:21,741 - jwst.extract_1d.extract - INFO - Working on slit 387
2025-09-13 16:45:21,742 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:45:21,743 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 24.00 (inclusive)
2025-09-13 16:45:21,796 - jwst.extract_1d.extract - INFO - Working on slit 505
2025-09-13 16:45:21,797 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:45:21,798 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 22.00 (inclusive)
2025-09-13 16:45:21,851 - jwst.extract_1d.extract - INFO - Working on slit 566
2025-09-13 16:45:21,852 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:45:21,853 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 24.00 (inclusive)
2025-09-13 16:45:21,906 - jwst.extract_1d.extract - INFO - Working on slit 772
2025-09-13 16:45:21,907 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:45:21,908 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 25.00 (inclusive)
2025-09-13 16:45:21,962 - jwst.extract_1d.extract - INFO - Working on slit 722
2025-09-13 16:45:21,963 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:45:21,964 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 31.00 (inclusive)
2025-09-13 16:45:22,016 - jwst.extract_1d.extract - INFO - Working on slit 872
2025-09-13 16:45:22,017 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type POINT
2025-09-13 16:45:22,018 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 10.00 (inclusive)
2025-09-13 16:45:22,025 - jwst.extract_1d.extract - INFO - Creating aperture correction.
2025-09-13 16:45:22,142 - jwst.extract_1d.extract - INFO - Working on slit 933
2025-09-13 16:45:22,143 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:45:22,144 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 36.00 (inclusive)
2025-09-13 16:45:22,199 - jwst.extract_1d.extract - INFO - Working on slit 1128
2025-09-13 16:45:22,200 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type POINT
2025-09-13 16:45:22,201 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 10.00 (inclusive)
2025-09-13 16:45:22,208 - jwst.extract_1d.extract - INFO - Creating aperture correction.
2025-09-13 16:45:22,324 - jwst.extract_1d.extract - INFO - Working on slit 1282
2025-09-13 16:45:22,325 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:45:22,326 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 34.00 (inclusive)
2025-09-13 16:45:22,381 - jwst.extract_1d.extract - INFO - Working on slit 274
2025-09-13 16:45:22,382 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:45:22,383 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 32.00 (inclusive)
2025-09-13 16:45:22,436 - jwst.extract_1d.extract - INFO - Working on slit 641
2025-09-13 16:45:22,437 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:45:22,438 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 29.00 (inclusive)
2025-09-13 16:45:22,490 - jwst.extract_1d.extract - INFO - Working on slit 543
2025-09-13 16:45:22,492 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:45:22,492 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 31.00 (inclusive)
2025-09-13 16:45:22,546 - jwst.extract_1d.extract - INFO - Working on slit 1188
2025-09-13 16:45:22,547 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:45:22,547 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 17.00 (inclusive)
2025-09-13 16:45:22,600 - jwst.extract_1d.extract - INFO - Working on slit 533
2025-09-13 16:45:22,601 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:45:22,602 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 25.00 (inclusive)
2025-09-13 16:45:22,654 - jwst.extract_1d.extract - INFO - Working on slit 1342
2025-09-13 16:45:22,655 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:45:22,656 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 21.00 (inclusive)
2025-09-13 16:45:22,983 - stpipe.Spec2Pipeline.extract_1d - INFO - Saved model in /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage2_spec/jw02079004003_03101_00001_nis_x1d.fits
2025-09-13 16:45:22,983 - stpipe.Spec2Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 16:45:22,986 - stpipe.Spec2Pipeline - INFO - Finished processing product /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage1/jw02079004003_03101_00001_nis
2025-09-13 16:45:22,990 - stpipe.Spec2Pipeline - INFO - Ending calwebb_spec2
2025-09-13 16:45:22,990 - jwst.stpipe.core - INFO - Results used CRDS context: jwst_1413.pmap
2025-09-13 16:45:34,369 - stpipe.Spec2Pipeline - INFO - Saved model in /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage2_spec/jw02079004003_03101_00001_nis_cal.fits
2025-09-13 16:45:34,370 - stpipe.Spec2Pipeline - INFO - Step Spec2Pipeline done
2025-09-13 16:45:34,371 - jwst.stpipe.core - INFO - Results used jwst version: 1.19.1
2025-09-13 16:45:34,383 - py.warnings - WARNING - /usr/share/miniconda/lib/python3.13/site-packages/jwst/associations/association.py:234: UserWarning: Input association file contains path information; note that this can complicate usage and/or sharing of such files.
warnings.warn(err_str, UserWarning, stacklevel=1)
2025-09-13 16:45:34,440 - stpipe - INFO - PARS-SPEC2PIPELINE parameters found: /home/runner/crds/references/jwst/niriss/jwst_niriss_pars-spec2pipeline_0005.asdf
2025-09-13 16:45:34,461 - stpipe.Spec2Pipeline - INFO - Spec2Pipeline instance created.
2025-09-13 16:45:34,463 - stpipe.Spec2Pipeline.assign_wcs - INFO - AssignWcsStep instance created.
2025-09-13 16:45:34,464 - stpipe.Spec2Pipeline.badpix_selfcal - INFO - BadpixSelfcalStep instance created.
2025-09-13 16:45:34,464 - stpipe.Spec2Pipeline.msa_flagging - INFO - MSAFlagOpenStep instance created.
2025-09-13 16:45:34,465 - stpipe.Spec2Pipeline.nsclean - INFO - NSCleanStep instance created.
2025-09-13 16:45:34,466 - stpipe.Spec2Pipeline.bkg_subtract - INFO - BackgroundStep instance created.
2025-09-13 16:45:34,467 - stpipe.Spec2Pipeline.imprint_subtract - INFO - ImprintStep instance created.
2025-09-13 16:45:34,468 - stpipe.Spec2Pipeline.extract_2d - INFO - Extract2dStep instance created.
2025-09-13 16:45:34,473 - stpipe.Spec2Pipeline.master_background_mos - INFO - MasterBackgroundMosStep instance created.
2025-09-13 16:45:34,473 - stpipe.Spec2Pipeline.master_background_mos.flat_field - INFO - FlatFieldStep instance created.
2025-09-13 16:45:34,474 - stpipe.Spec2Pipeline.master_background_mos.pathloss - INFO - PathLossStep instance created.
2025-09-13 16:45:34,475 - stpipe.Spec2Pipeline.master_background_mos.barshadow - INFO - BarShadowStep instance created.
2025-09-13 16:45:34,476 - stpipe.Spec2Pipeline.master_background_mos.photom - INFO - PhotomStep instance created.
2025-09-13 16:45:34,477 - stpipe.Spec2Pipeline.master_background_mos.pixel_replace - INFO - PixelReplaceStep instance created.
2025-09-13 16:45:34,477 - stpipe.Spec2Pipeline.master_background_mos.resample_spec - INFO - ResampleSpecStep instance created.
2025-09-13 16:45:34,479 - stpipe.Spec2Pipeline.master_background_mos.extract_1d - INFO - Extract1dStep instance created.
2025-09-13 16:45:34,480 - stpipe.Spec2Pipeline.wavecorr - INFO - WavecorrStep instance created.
2025-09-13 16:45:34,480 - stpipe.Spec2Pipeline.flat_field - INFO - FlatFieldStep instance created.
2025-09-13 16:45:34,481 - stpipe.Spec2Pipeline.srctype - INFO - SourceTypeStep instance created.
2025-09-13 16:45:34,482 - stpipe.Spec2Pipeline.straylight - INFO - StraylightStep instance created.
2025-09-13 16:45:34,483 - stpipe.Spec2Pipeline.fringe - INFO - FringeStep instance created.
2025-09-13 16:45:34,483 - stpipe.Spec2Pipeline.residual_fringe - INFO - ResidualFringeStep instance created.
2025-09-13 16:45:34,484 - stpipe.Spec2Pipeline.pathloss - INFO - PathLossStep instance created.
2025-09-13 16:45:34,485 - stpipe.Spec2Pipeline.barshadow - INFO - BarShadowStep instance created.
2025-09-13 16:45:34,486 - stpipe.Spec2Pipeline.wfss_contam - INFO - WfssContamStep instance created.
2025-09-13 16:45:34,487 - stpipe.Spec2Pipeline.photom - INFO - PhotomStep instance created.
2025-09-13 16:45:34,488 - stpipe.Spec2Pipeline.pixel_replace - INFO - PixelReplaceStep instance created.
2025-09-13 16:45:34,489 - stpipe.Spec2Pipeline.resample_spec - INFO - ResampleSpecStep instance created.
2025-09-13 16:45:34,490 - stpipe.Spec2Pipeline.cube_build - INFO - CubeBuildStep instance created.
2025-09-13 16:45:34,491 - stpipe.Spec2Pipeline.extract_1d - INFO - Extract1dStep instance created.
2025-09-13 16:45:35,197 - stpipe.Spec2Pipeline - INFO - Step Spec2Pipeline running with args ('/home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/jw02079004003_03101_00002_nis_spec2_asn.json',).
2025-09-13 16:45:35,232 - stpipe.Spec2Pipeline - INFO - Step Spec2Pipeline parameters are:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage2_spec
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: True
skip: False
suffix: None
search_output_file: True
input_dir: ''
save_bsub: False
fail_on_exception: True
save_wfss_esec: False
steps:
assign_wcs:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
sip_approx: True
sip_max_pix_error: 0.01
sip_degree: None
sip_max_inv_pix_error: 0.01
sip_inv_degree: None
sip_npoints: 12
slit_y_low: -0.55
slit_y_high: 0.55
nrs_ifu_slice_wcs: False
badpix_selfcal:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: True
suffix: None
search_output_file: True
input_dir: ''
flagfrac_lower: 0.001
flagfrac_upper: 0.001
kernel_size: 15
force_single: False
save_flagged_bkg: False
msa_flagging:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
nsclean:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: True
suffix: None
search_output_file: True
input_dir: ''
fit_method: fft
fit_by_channel: False
background_method: None
background_box_size: None
mask_spectral_regions: True
n_sigma: 5.0
fit_histogram: False
single_mask: False
user_mask: None
save_mask: False
save_background: False
save_noise: False
bkg_subtract:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
bkg_list: None
save_combined_background: False
sigma: 3.0
maxiters: None
soss_source_percentile: 35.0
soss_bkg_percentile: None
wfss_mmag_extract: None
wfss_maxiter: 5
wfss_rms_stop: 0.0
wfss_outlier_percent: 1.0
imprint_subtract:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
extract_2d:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
slit_names: None
source_ids: None
extract_orders: None
grism_objects: None
tsgrism_extract_height: None
wfss_extract_half_height: 5
wfss_mmag_extract: None
wfss_nbright: 100
master_background_mos:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: True
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
sigma_clip: 3.0
median_kernel: 1
force_subtract: False
save_background: False
user_background: None
inverse: False
steps:
flat_field:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
save_interpolated_flat: False
user_supplied_flat: None
inverse: False
pathloss:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
inverse: False
source_type: None
user_slit_loc: None
barshadow:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
inverse: False
source_type: None
photom:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
inverse: False
source_type: None
mrs_time_correction: True
pixel_replace:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: True
output_use_index: True
save_results: False
skip: True
suffix: None
search_output_file: True
input_dir: ''
algorithm: fit_profile
n_adjacent_cols: 3
resample_spec:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
pixfrac: 1.0
kernel: square
fillval: NAN
weight_type: ivm
output_shape: None
pixel_scale_ratio: 1.0
pixel_scale: None
output_wcs: ''
single: False
blendheaders: True
in_memory: True
extract_1d:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
subtract_background: None
apply_apcorr: True
extraction_type: box
use_source_posn: None
position_offset: 0.0
model_nod_pair: True
optimize_psf_location: True
smoothing_length: None
bkg_fit: None
bkg_order: None
log_increment: 50
save_profile: False
save_scene_model: False
save_residual_image: False
center_xy: None
ifu_autocen: False
bkg_sigma_clip: 3.0
ifu_rfcorr: True
ifu_set_srctype: None
ifu_rscale: None
ifu_covar_scale: 1.0
soss_atoca: True
soss_threshold: 0.01
soss_n_os: 2
soss_wave_grid_in: None
soss_wave_grid_out: None
soss_estimate: None
soss_rtol: 0.0001
soss_max_grid_size: 20000
soss_tikfac: None
soss_width: 40.0
soss_bad_pix: masking
soss_modelname: None
wavecorr:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
flat_field:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
save_interpolated_flat: False
user_supplied_flat: None
inverse: False
srctype:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
source_type: None
straylight:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
clean_showers: False
shower_plane: 3
shower_x_stddev: 18.0
shower_y_stddev: 5.0
shower_low_reject: 0.1
shower_high_reject: 99.9
save_shower_model: False
fringe:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
residual_fringe:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: True
suffix: residual_fringe
search_output_file: False
input_dir: ''
save_intermediate_results: False
ignore_region_min: None
ignore_region_max: None
pathloss:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
inverse: False
source_type: None
user_slit_loc: None
barshadow:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
inverse: False
source_type: None
wfss_contam:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: True
suffix: None
search_output_file: True
input_dir: ''
save_simulated_image: False
save_contam_images: False
maximum_cores: none
photom:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
inverse: False
source_type: None
mrs_time_correction: True
pixel_replace:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: True
output_use_index: True
save_results: False
skip: True
suffix: None
search_output_file: True
input_dir: ''
algorithm: fit_profile
n_adjacent_cols: 3
resample_spec:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
pixfrac: 1.0
kernel: square
fillval: NAN
weight_type: ivm
output_shape: None
pixel_scale_ratio: 1.0
pixel_scale: None
output_wcs: ''
single: False
blendheaders: True
in_memory: True
cube_build:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: True
output_use_index: True
save_results: False
skip: False
suffix: s3d
search_output_file: False
input_dir: ''
channel: all
band: all
grating: all
filter: all
output_type: None
scalexy: 0.0
scalew: 0.0
weighting: drizzle
coord_system: skyalign
ra_center: None
dec_center: None
cube_pa: None
nspax_x: None
nspax_y: None
rois: 0.0
roiw: 0.0
weight_power: 2.0
wavemin: None
wavemax: None
single: False
skip_dqflagging: False
offset_file: None
debug_spaxel: -1 -1 -1
extract_1d:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
subtract_background: None
apply_apcorr: True
extraction_type: box
use_source_posn: None
position_offset: 0.0
model_nod_pair: True
optimize_psf_location: True
smoothing_length: None
bkg_fit: None
bkg_order: None
log_increment: 50
save_profile: False
save_scene_model: False
save_residual_image: False
center_xy: None
ifu_autocen: False
bkg_sigma_clip: 3.0
ifu_rfcorr: True
ifu_set_srctype: None
ifu_rscale: None
ifu_covar_scale: 1.0
soss_atoca: True
soss_threshold: 0.01
soss_n_os: 2
soss_wave_grid_in: None
soss_wave_grid_out: None
soss_estimate: None
soss_rtol: 0.0001
soss_max_grid_size: 20000
soss_tikfac: None
soss_width: 40.0
soss_bad_pix: masking
soss_modelname: None
2025-09-13 16:45:35,282 - stpipe.Spec2Pipeline - INFO - Prefetching reference files for dataset: 'jw02079004003_03101_00002_nis_spec2_asn.json' reftypes = ['apcorr', 'area', 'barshadow', 'bkg', 'camera', 'collimator', 'cubepar', 'dflat', 'disperser', 'distortion', 'extract1d', 'fflat', 'filteroffset', 'flat', 'fore', 'fpa', 'fringe', 'ifufore', 'ifupost', 'ifuslicer', 'mrsxartcorr', 'msa', 'msaoper', 'ote', 'pastasoss', 'pathloss', 'photom', 'psf', 'regions', 'sflat', 'speckernel', 'specprofile', 'specwcs', 'wavecorr', 'wavelengthrange']
2025-09-13 16:45:35,286 - stpipe.Spec2Pipeline - INFO - Prefetch for APCORR reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits'.
2025-09-13 16:45:35,286 - stpipe.Spec2Pipeline - INFO - Prefetch for AREA reference file is 'N/A'.
2025-09-13 16:45:35,286 - stpipe.Spec2Pipeline - INFO - Prefetch for BARSHADOW reference file is 'N/A'.
2025-09-13 16:45:35,287 - stpipe.Spec2Pipeline - INFO - Prefetch for BKG reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_bkg_0029.fits'.
2025-09-13 16:45:35,287 - stpipe.Spec2Pipeline - INFO - Prefetch for CAMERA reference file is 'N/A'.
2025-09-13 16:45:35,288 - stpipe.Spec2Pipeline - INFO - Prefetch for COLLIMATOR reference file is 'N/A'.
2025-09-13 16:45:35,288 - stpipe.Spec2Pipeline - INFO - Prefetch for CUBEPAR reference file is 'N/A'.
2025-09-13 16:45:35,288 - stpipe.Spec2Pipeline - INFO - Prefetch for DFLAT reference file is 'N/A'.
2025-09-13 16:45:35,289 - stpipe.Spec2Pipeline - INFO - Prefetch for DISPERSER reference file is 'N/A'.
2025-09-13 16:45:35,289 - stpipe.Spec2Pipeline - INFO - Prefetch for DISTORTION reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_distortion_0037.asdf'.
2025-09-13 16:45:35,289 - stpipe.Spec2Pipeline - INFO - Prefetch for EXTRACT1D reference file is 'N/A'.
2025-09-13 16:45:35,290 - stpipe.Spec2Pipeline - INFO - Prefetch for FFLAT reference file is 'N/A'.
2025-09-13 16:45:35,290 - stpipe.Spec2Pipeline - INFO - Prefetch for FILTEROFFSET reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_filteroffset_0006.asdf'.
2025-09-13 16:45:35,290 - stpipe.Spec2Pipeline - INFO - Prefetch for FLAT reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_flat_0271.fits'.
2025-09-13 16:45:35,291 - stpipe.Spec2Pipeline - INFO - Prefetch for FORE reference file is 'N/A'.
2025-09-13 16:45:35,291 - stpipe.Spec2Pipeline - INFO - Prefetch for FPA reference file is 'N/A'.
2025-09-13 16:45:35,291 - stpipe.Spec2Pipeline - INFO - Prefetch for FRINGE reference file is 'N/A'.
2025-09-13 16:45:35,292 - stpipe.Spec2Pipeline - INFO - Prefetch for IFUFORE reference file is 'N/A'.
2025-09-13 16:45:35,292 - stpipe.Spec2Pipeline - INFO - Prefetch for IFUPOST reference file is 'N/A'.
2025-09-13 16:45:35,292 - stpipe.Spec2Pipeline - INFO - Prefetch for IFUSLICER reference file is 'N/A'.
2025-09-13 16:45:35,293 - stpipe.Spec2Pipeline - INFO - Prefetch for MRSXARTCORR reference file is 'N/A'.
2025-09-13 16:45:35,293 - stpipe.Spec2Pipeline - INFO - Prefetch for MSA reference file is 'N/A'.
2025-09-13 16:45:35,293 - stpipe.Spec2Pipeline - INFO - Prefetch for MSAOPER reference file is 'N/A'.
2025-09-13 16:45:35,294 - stpipe.Spec2Pipeline - INFO - Prefetch for OTE reference file is 'N/A'.
2025-09-13 16:45:35,294 - stpipe.Spec2Pipeline - INFO - Prefetch for PASTASOSS reference file is 'N/A'.
2025-09-13 16:45:35,294 - stpipe.Spec2Pipeline - INFO - Prefetch for PATHLOSS reference file is 'N/A'.
2025-09-13 16:45:35,294 - stpipe.Spec2Pipeline - INFO - Prefetch for PHOTOM reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_photom_0041.fits'.
2025-09-13 16:45:35,295 - stpipe.Spec2Pipeline - INFO - Prefetch for PSF reference file is 'N/A'.
2025-09-13 16:45:35,295 - stpipe.Spec2Pipeline - INFO - Prefetch for REGIONS reference file is 'N/A'.
2025-09-13 16:45:35,295 - stpipe.Spec2Pipeline - INFO - Prefetch for SFLAT reference file is 'N/A'.
2025-09-13 16:45:35,296 - stpipe.Spec2Pipeline - INFO - Prefetch for SPECKERNEL reference file is 'N/A'.
2025-09-13 16:45:35,296 - stpipe.Spec2Pipeline - INFO - Prefetch for SPECPROFILE reference file is 'N/A'.
2025-09-13 16:45:35,296 - stpipe.Spec2Pipeline - INFO - Prefetch for SPECWCS reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_specwcs_0065.asdf'.
2025-09-13 16:45:35,297 - stpipe.Spec2Pipeline - INFO - Prefetch for WAVECORR reference file is 'N/A'.
2025-09-13 16:45:35,297 - stpipe.Spec2Pipeline - INFO - Prefetch for WAVELENGTHRANGE reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_wavelengthrange_0002.asdf'.
2025-09-13 16:45:35,297 - stpipe.Spec2Pipeline - INFO - Starting calwebb_spec2 ...
2025-09-13 16:45:35,305 - stpipe.Spec2Pipeline - INFO - Processing product /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage1/jw02079004003_03101_00002_nis
2025-09-13 16:45:35,305 - stpipe.Spec2Pipeline - INFO - Working on input /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage1/jw02079004003_03101_00002_nis_rate.fits ...
2025-09-13 16:45:35,354 - stpipe.Spec2Pipeline - INFO - Using sourcecat file jw02079-o004_niriss_clear-f200w_cat.ecsv
2025-09-13 16:45:35,355 - stpipe.Spec2Pipeline - INFO - Using segmentation map jw02079-o004_niriss_clear-f200w_segm.fits
2025-09-13 16:45:35,355 - stpipe.Spec2Pipeline - INFO - Using direct image jw02079-o004_niriss_clear-f200w_i2d.fits
2025-09-13 16:45:35,748 - stpipe.Spec2Pipeline.assign_wcs - INFO - Step assign_wcs running with args (<ImageModel(2048, 2048) from jw02079004003_03101_00002_nis_rate.fits>,).
2025-09-13 16:45:35,863 - jwst.assign_wcs.niriss - INFO - Added Barycentric velocity correction: 0.9999282763888806
2025-09-13 16:45:35,921 - jwst.assign_wcs.niriss - INFO - Offsets from filteroffset file are 2.119, -1.0476
2025-09-13 16:45:35,999 - jwst.assign_wcs.assign_wcs - INFO - COMPLETED assign_wcs
2025-09-13 16:45:36,000 - stpipe.AssignWcsStep - INFO - AssignWcsStep instance created.
2025-09-13 16:45:36,078 - jwst.assign_wcs.niriss - INFO - Offsets from filteroffset file are 2.119, -1.0476
2025-09-13 16:45:36,127 - stpipe.Spec2Pipeline.assign_wcs - INFO - Step assign_wcs done
2025-09-13 16:45:36,520 - stpipe.Spec2Pipeline.badpix_selfcal - INFO - Step badpix_selfcal running with args (<ImageModel(2048, 2048) from jw02079004003_03101_00002_nis_rate.fits>, [], []).
2025-09-13 16:45:36,521 - stpipe.Spec2Pipeline.badpix_selfcal - INFO - Step skipped.
2025-09-13 16:45:36,907 - stpipe.Spec2Pipeline.msa_flagging - INFO - Step msa_flagging running with args (<ImageModel(2048, 2048) from jw02079004003_03101_00002_nis_rate.fits>,).
2025-09-13 16:45:36,907 - stpipe.Spec2Pipeline.msa_flagging - INFO - Step skipped.
2025-09-13 16:45:37,300 - stpipe.Spec2Pipeline.nsclean - INFO - Step nsclean running with args (<ImageModel(2048, 2048) from jw02079004003_03101_00002_nis_rate.fits>,).
2025-09-13 16:45:37,301 - stpipe.Spec2Pipeline.nsclean - INFO - Step skipped.
2025-09-13 16:45:37,687 - stpipe.Spec2Pipeline.imprint_subtract - INFO - Step imprint_subtract running with args (<ImageModel(2048, 2048) from jw02079004003_03101_00002_nis_rate.fits>, []).
2025-09-13 16:45:37,687 - stpipe.Spec2Pipeline.imprint_subtract - INFO - Step skipped.
2025-09-13 16:45:38,070 - stpipe.Spec2Pipeline.bkg_subtract - INFO - Step bkg_subtract running with args (<ImageModel(2048, 2048) from jw02079004003_03101_00002_nis_rate.fits>, []).
2025-09-13 16:45:38,334 - jwst.background.asn_intake - INFO - Working on input <ImageModel(2048, 2048) from jw02079004003_03101_00002_nis_rate.fits> ...
2025-09-13 16:45:38,635 - stpipe.Spec2Pipeline.bkg_subtract - INFO - Using BKG reference file /home/runner/crds/references/jwst/niriss/jwst_niriss_bkg_0029.fits
2025-09-13 16:45:38,635 - stpipe.Spec2Pipeline.bkg_subtract - INFO - Using WavelengthRange reference file /home/runner/crds/references/jwst/niriss/jwst_niriss_wavelengthrange_0002.asdf
2025-09-13 16:45:38,701 - jwst.assign_wcs.util - INFO - Getting objects from jw02079-o004_niriss_clear-f200w_cat.ecsv
2025-09-13 16:45:39,017 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1, order 1
2025-09-13 16:45:39,030 - jwst.assign_wcs.util - INFO - Excluding off-image object: 2, order 1
2025-09-13 16:45:39,042 - jwst.assign_wcs.util - INFO - Excluding off-image object: 3, order 1
2025-09-13 16:45:39,054 - jwst.assign_wcs.util - INFO - Excluding off-image object: 4, order 1
2025-09-13 16:45:39,066 - jwst.assign_wcs.util - INFO - Excluding off-image object: 5, order 1
2025-09-13 16:45:39,079 - jwst.assign_wcs.util - INFO - Excluding off-image object: 6, order 1
2025-09-13 16:45:39,092 - jwst.assign_wcs.util - INFO - Excluding off-image object: 7, order 1
2025-09-13 16:45:39,104 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 8 order: 1
2025-09-13 16:45:39,117 - jwst.assign_wcs.util - INFO - Excluding off-image object: 9, order 1
2025-09-13 16:45:39,129 - jwst.assign_wcs.util - INFO - Excluding off-image object: 10, order 1
2025-09-13 16:45:39,142 - jwst.assign_wcs.util - INFO - Excluding off-image object: 11, order 1
2025-09-13 16:45:39,155 - jwst.assign_wcs.util - INFO - Excluding off-image object: 12, order 1
2025-09-13 16:45:39,167 - jwst.assign_wcs.util - INFO - Excluding off-image object: 13, order 1
2025-09-13 16:45:39,180 - jwst.assign_wcs.util - INFO - Excluding off-image object: 14, order 1
2025-09-13 16:45:39,192 - jwst.assign_wcs.util - INFO - Excluding off-image object: 15, order 1
2025-09-13 16:45:39,205 - jwst.assign_wcs.util - INFO - Excluding off-image object: 16, order 1
2025-09-13 16:45:39,218 - jwst.assign_wcs.util - INFO - Excluding off-image object: 17, order 1
2025-09-13 16:45:39,230 - jwst.assign_wcs.util - INFO - Excluding off-image object: 18, order 1
2025-09-13 16:45:39,243 - jwst.assign_wcs.util - INFO - Excluding off-image object: 19, order 1
2025-09-13 16:45:39,256 - jwst.assign_wcs.util - INFO - Excluding off-image object: 20, order 1
2025-09-13 16:45:39,268 - jwst.assign_wcs.util - INFO - Excluding off-image object: 21, order 1
2025-09-13 16:45:39,280 - jwst.assign_wcs.util - INFO - Excluding off-image object: 22, order 1
2025-09-13 16:45:39,292 - jwst.assign_wcs.util - INFO - Excluding off-image object: 23, order 1
2025-09-13 16:45:39,305 - jwst.assign_wcs.util - INFO - Excluding off-image object: 24, order 1
2025-09-13 16:45:39,318 - jwst.assign_wcs.util - INFO - Excluding off-image object: 25, order 1
2025-09-13 16:45:39,330 - jwst.assign_wcs.util - INFO - Excluding off-image object: 26, order 1
2025-09-13 16:45:39,342 - jwst.assign_wcs.util - INFO - Excluding off-image object: 27, order 1
2025-09-13 16:45:39,355 - jwst.assign_wcs.util - INFO - Excluding off-image object: 28, order 1
2025-09-13 16:45:39,367 - jwst.assign_wcs.util - INFO - Excluding off-image object: 29, order 1
2025-09-13 16:45:39,379 - jwst.assign_wcs.util - INFO - Excluding off-image object: 30, order 1
2025-09-13 16:45:39,392 - jwst.assign_wcs.util - INFO - Excluding off-image object: 31, order 1
2025-09-13 16:45:39,404 - jwst.assign_wcs.util - INFO - Excluding off-image object: 32, order 1
2025-09-13 16:45:39,417 - jwst.assign_wcs.util - INFO - Excluding off-image object: 33, order 1
2025-09-13 16:45:39,429 - jwst.assign_wcs.util - INFO - Excluding off-image object: 34, order 1
2025-09-13 16:45:39,442 - jwst.assign_wcs.util - INFO - Excluding off-image object: 35, order 1
2025-09-13 16:45:39,454 - jwst.assign_wcs.util - INFO - Excluding off-image object: 36, order 1
2025-09-13 16:45:39,467 - jwst.assign_wcs.util - INFO - Excluding off-image object: 37, order 1
2025-09-13 16:45:39,479 - jwst.assign_wcs.util - INFO - Excluding off-image object: 38, order 1
2025-09-13 16:45:39,492 - jwst.assign_wcs.util - INFO - Excluding off-image object: 39, order 1
2025-09-13 16:45:39,504 - jwst.assign_wcs.util - INFO - Excluding off-image object: 40, order 1
2025-09-13 16:45:39,516 - jwst.assign_wcs.util - INFO - Excluding off-image object: 41, order 1
2025-09-13 16:45:39,529 - jwst.assign_wcs.util - INFO - Excluding off-image object: 42, order 1
2025-09-13 16:45:39,541 - jwst.assign_wcs.util - INFO - Excluding off-image object: 43, order 1
2025-09-13 16:45:39,553 - jwst.assign_wcs.util - INFO - Excluding off-image object: 44, order 1
2025-09-13 16:45:39,566 - jwst.assign_wcs.util - INFO - Excluding off-image object: 45, order 1
2025-09-13 16:45:39,578 - jwst.assign_wcs.util - INFO - Excluding off-image object: 46, order 1
2025-09-13 16:45:39,591 - jwst.assign_wcs.util - INFO - Excluding off-image object: 47, order 1
2025-09-13 16:45:39,603 - jwst.assign_wcs.util - INFO - Excluding off-image object: 48, order 1
2025-09-13 16:45:39,616 - jwst.assign_wcs.util - INFO - Excluding off-image object: 49, order 1
2025-09-13 16:45:39,628 - jwst.assign_wcs.util - INFO - Excluding off-image object: 50, order 1
2025-09-13 16:45:39,641 - jwst.assign_wcs.util - INFO - Excluding off-image object: 51, order 1
2025-09-13 16:45:39,654 - jwst.assign_wcs.util - INFO - Excluding off-image object: 52, order 1
2025-09-13 16:45:39,667 - jwst.assign_wcs.util - INFO - Excluding off-image object: 53, order 1
2025-09-13 16:45:39,679 - jwst.assign_wcs.util - INFO - Excluding off-image object: 54, order 1
2025-09-13 16:45:39,691 - jwst.assign_wcs.util - INFO - Excluding off-image object: 55, order 1
2025-09-13 16:45:39,704 - jwst.assign_wcs.util - INFO - Excluding off-image object: 56, order 1
2025-09-13 16:45:39,717 - jwst.assign_wcs.util - INFO - Excluding off-image object: 57, order 1
2025-09-13 16:45:39,730 - jwst.assign_wcs.util - INFO - Excluding off-image object: 58, order 1
2025-09-13 16:45:39,745 - jwst.assign_wcs.util - INFO - Excluding off-image object: 59, order 1
2025-09-13 16:45:39,758 - jwst.assign_wcs.util - INFO - Excluding off-image object: 60, order 1
2025-09-13 16:45:39,771 - jwst.assign_wcs.util - INFO - Excluding off-image object: 61, order 1
2025-09-13 16:45:39,784 - jwst.assign_wcs.util - INFO - Excluding off-image object: 62, order 1
2025-09-13 16:45:39,796 - jwst.assign_wcs.util - INFO - Excluding off-image object: 63, order 1
2025-09-13 16:45:39,809 - jwst.assign_wcs.util - INFO - Excluding off-image object: 64, order 1
2025-09-13 16:45:39,821 - jwst.assign_wcs.util - INFO - Excluding off-image object: 65, order 1
2025-09-13 16:45:39,834 - jwst.assign_wcs.util - INFO - Excluding off-image object: 66, order 1
2025-09-13 16:45:39,847 - jwst.assign_wcs.util - INFO - Excluding off-image object: 67, order 1
2025-09-13 16:45:39,859 - jwst.assign_wcs.util - INFO - Excluding off-image object: 68, order 1
2025-09-13 16:45:39,872 - jwst.assign_wcs.util - INFO - Excluding off-image object: 69, order 1
2025-09-13 16:45:39,884 - jwst.assign_wcs.util - INFO - Excluding off-image object: 70, order 1
2025-09-13 16:45:39,896 - jwst.assign_wcs.util - INFO - Excluding off-image object: 71, order 1
2025-09-13 16:45:39,909 - jwst.assign_wcs.util - INFO - Excluding off-image object: 72, order 1
2025-09-13 16:45:39,921 - jwst.assign_wcs.util - INFO - Excluding off-image object: 73, order 1
2025-09-13 16:45:39,934 - jwst.assign_wcs.util - INFO - Excluding off-image object: 74, order 1
2025-09-13 16:45:39,946 - jwst.assign_wcs.util - INFO - Excluding off-image object: 75, order 1
2025-09-13 16:45:39,958 - jwst.assign_wcs.util - INFO - Excluding off-image object: 76, order 1
2025-09-13 16:45:39,971 - jwst.assign_wcs.util - INFO - Excluding off-image object: 77, order 1
2025-09-13 16:45:39,983 - jwst.assign_wcs.util - INFO - Excluding off-image object: 78, order 1
2025-09-13 16:45:39,995 - jwst.assign_wcs.util - INFO - Excluding off-image object: 79, order 1
2025-09-13 16:45:40,008 - jwst.assign_wcs.util - INFO - Excluding off-image object: 80, order 1
2025-09-13 16:45:40,020 - jwst.assign_wcs.util - INFO - Excluding off-image object: 81, order 1
2025-09-13 16:45:40,032 - jwst.assign_wcs.util - INFO - Excluding off-image object: 82, order 1
2025-09-13 16:45:40,045 - jwst.assign_wcs.util - INFO - Excluding off-image object: 83, order 1
2025-09-13 16:45:40,057 - jwst.assign_wcs.util - INFO - Excluding off-image object: 84, order 1
2025-09-13 16:45:40,069 - jwst.assign_wcs.util - INFO - Excluding off-image object: 85, order 1
2025-09-13 16:45:40,081 - jwst.assign_wcs.util - INFO - Excluding off-image object: 86, order 1
2025-09-13 16:45:40,093 - jwst.assign_wcs.util - INFO - Excluding off-image object: 87, order 1
2025-09-13 16:45:40,106 - jwst.assign_wcs.util - INFO - Excluding off-image object: 88, order 1
2025-09-13 16:45:40,118 - jwst.assign_wcs.util - INFO - Excluding off-image object: 89, order 1
2025-09-13 16:45:40,130 - jwst.assign_wcs.util - INFO - Excluding off-image object: 90, order 1
2025-09-13 16:45:40,142 - jwst.assign_wcs.util - INFO - Excluding off-image object: 91, order 1
2025-09-13 16:45:40,154 - jwst.assign_wcs.util - INFO - Excluding off-image object: 92, order 1
2025-09-13 16:45:40,167 - jwst.assign_wcs.util - INFO - Excluding off-image object: 93, order 1
2025-09-13 16:45:40,179 - jwst.assign_wcs.util - INFO - Excluding off-image object: 94, order 1
2025-09-13 16:45:40,191 - jwst.assign_wcs.util - INFO - Excluding off-image object: 95, order 1
2025-09-13 16:45:40,203 - jwst.assign_wcs.util - INFO - Excluding off-image object: 96, order 1
2025-09-13 16:45:40,215 - jwst.assign_wcs.util - INFO - Excluding off-image object: 97, order 1
2025-09-13 16:45:40,227 - jwst.assign_wcs.util - INFO - Excluding off-image object: 98, order 1
2025-09-13 16:45:40,239 - jwst.assign_wcs.util - INFO - Excluding off-image object: 99, order 1
2025-09-13 16:45:40,251 - jwst.assign_wcs.util - INFO - Excluding off-image object: 100, order 1
2025-09-13 16:45:40,263 - jwst.assign_wcs.util - INFO - Excluding off-image object: 101, order 1
2025-09-13 16:45:40,276 - jwst.assign_wcs.util - INFO - Excluding off-image object: 102, order 1
2025-09-13 16:45:40,288 - jwst.assign_wcs.util - INFO - Excluding off-image object: 103, order 1
2025-09-13 16:45:40,300 - jwst.assign_wcs.util - INFO - Excluding off-image object: 104, order 1
2025-09-13 16:45:40,312 - jwst.assign_wcs.util - INFO - Excluding off-image object: 105, order 1
2025-09-13 16:45:40,325 - jwst.assign_wcs.util - INFO - Excluding off-image object: 106, order 1
2025-09-13 16:45:40,337 - jwst.assign_wcs.util - INFO - Excluding off-image object: 107, order 1
2025-09-13 16:45:40,349 - jwst.assign_wcs.util - INFO - Excluding off-image object: 108, order 1
2025-09-13 16:45:40,361 - jwst.assign_wcs.util - INFO - Excluding off-image object: 109, order 1
2025-09-13 16:45:40,372 - jwst.assign_wcs.util - INFO - Excluding off-image object: 110, order 1
2025-09-13 16:45:40,385 - jwst.assign_wcs.util - INFO - Excluding off-image object: 111, order 1
2025-09-13 16:45:40,399 - jwst.assign_wcs.util - INFO - Excluding off-image object: 112, order 1
2025-09-13 16:45:40,411 - jwst.assign_wcs.util - INFO - Excluding off-image object: 113, order 1
2025-09-13 16:45:40,423 - jwst.assign_wcs.util - INFO - Excluding off-image object: 114, order 1
2025-09-13 16:45:40,435 - jwst.assign_wcs.util - INFO - Excluding off-image object: 115, order 1
2025-09-13 16:45:40,447 - jwst.assign_wcs.util - INFO - Excluding off-image object: 116, order 1
2025-09-13 16:45:40,467 - jwst.assign_wcs.util - INFO - Excluding off-image object: 117, order 1
2025-09-13 16:45:40,479 - jwst.assign_wcs.util - INFO - Excluding off-image object: 118, order 1
2025-09-13 16:45:40,491 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 119 order: 1
2025-09-13 16:45:40,504 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 120 order: 1
2025-09-13 16:45:40,516 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 121 order: 1
2025-09-13 16:45:40,529 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 122 order: 1
2025-09-13 16:45:40,541 - jwst.assign_wcs.util - INFO - Excluding off-image object: 123, order 1
2025-09-13 16:45:40,553 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 124 order: 1
2025-09-13 16:45:40,566 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 125 order: 1
2025-09-13 16:45:40,578 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 126 order: 1
2025-09-13 16:45:40,590 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 127 order: 1
2025-09-13 16:45:40,602 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 128 order: 1
2025-09-13 16:45:40,614 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 129 order: 1
2025-09-13 16:45:40,627 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 130 order: 1
2025-09-13 16:45:40,639 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 131 order: 1
2025-09-13 16:45:40,651 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 132 order: 1
2025-09-13 16:45:40,663 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 133 order: 1
2025-09-13 16:45:40,675 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 134 order: 1
2025-09-13 16:45:40,687 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 135 order: 1
2025-09-13 16:45:40,700 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 136 order: 1
2025-09-13 16:45:40,712 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 137 order: 1
2025-09-13 16:45:40,724 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 138 order: 1
2025-09-13 16:45:40,736 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 139 order: 1
2025-09-13 16:45:40,748 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 140 order: 1
2025-09-13 16:45:40,760 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 141 order: 1
2025-09-13 16:45:40,772 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 142 order: 1
2025-09-13 16:45:40,784 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 143 order: 1
2025-09-13 16:45:40,796 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 144 order: 1
2025-09-13 16:45:40,808 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 145 order: 1
2025-09-13 16:45:40,821 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 146 order: 1
2025-09-13 16:45:40,833 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 147 order: 1
2025-09-13 16:45:40,845 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 148 order: 1
2025-09-13 16:45:40,857 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 149 order: 1
2025-09-13 16:45:40,869 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 150 order: 1
2025-09-13 16:45:40,883 - jwst.assign_wcs.util - INFO - Excluding off-image object: 151, order 1
2025-09-13 16:45:40,895 - jwst.assign_wcs.util - INFO - Excluding off-image object: 152, order 1
2025-09-13 16:45:40,908 - jwst.assign_wcs.util - INFO - Excluding off-image object: 153, order 1
2025-09-13 16:45:40,920 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 154 order: 1
2025-09-13 16:45:40,932 - jwst.assign_wcs.util - INFO - Excluding off-image object: 155, order 1
2025-09-13 16:45:40,944 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 156 order: 1
2025-09-13 16:45:40,956 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 157 order: 1
2025-09-13 16:45:40,968 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 158 order: 1
2025-09-13 16:45:40,981 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 159 order: 1
2025-09-13 16:45:40,993 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 160 order: 1
2025-09-13 16:45:41,005 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 161 order: 1
2025-09-13 16:45:41,017 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 162 order: 1
2025-09-13 16:45:41,029 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 163 order: 1
2025-09-13 16:45:41,041 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 164 order: 1
2025-09-13 16:45:41,053 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 165 order: 1
2025-09-13 16:45:41,065 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 166 order: 1
2025-09-13 16:45:41,077 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 167 order: 1
2025-09-13 16:45:41,090 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 168 order: 1
2025-09-13 16:45:41,102 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 169 order: 1
2025-09-13 16:45:41,114 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 170 order: 1
2025-09-13 16:45:41,126 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 171 order: 1
2025-09-13 16:45:41,138 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 172 order: 1
2025-09-13 16:45:41,150 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 173 order: 1
2025-09-13 16:45:41,163 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 174 order: 1
2025-09-13 16:45:41,175 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 175 order: 1
2025-09-13 16:45:41,187 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 176 order: 1
2025-09-13 16:45:41,199 - jwst.assign_wcs.util - INFO - Excluding off-image object: 177, order 1
2025-09-13 16:45:41,211 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 178 order: 1
2025-09-13 16:45:41,223 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 179 order: 1
2025-09-13 16:45:41,235 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 180 order: 1
2025-09-13 16:45:41,247 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 181 order: 1
2025-09-13 16:45:41,259 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 182 order: 1
2025-09-13 16:45:41,271 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 183 order: 1
2025-09-13 16:45:41,283 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 184 order: 1
2025-09-13 16:45:41,295 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 185 order: 1
2025-09-13 16:45:41,307 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 186 order: 1
2025-09-13 16:45:41,319 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 187 order: 1
2025-09-13 16:45:41,331 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 188 order: 1
2025-09-13 16:45:41,343 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 189 order: 1
2025-09-13 16:45:41,355 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 190 order: 1
2025-09-13 16:45:41,367 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 191 order: 1
2025-09-13 16:45:41,379 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 192 order: 1
2025-09-13 16:45:41,392 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 193 order: 1
2025-09-13 16:45:41,416 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 195 order: 1
2025-09-13 16:45:41,440 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 197 order: 1
2025-09-13 16:45:41,452 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 198 order: 1
2025-09-13 16:45:41,510 - jwst.assign_wcs.util - INFO - Excluding off-image object: 203, order 1
2025-09-13 16:45:41,556 - jwst.assign_wcs.util - INFO - Excluding off-image object: 207, order 1
2025-09-13 16:45:41,697 - jwst.assign_wcs.util - INFO - Excluding off-image object: 219, order 1
2025-09-13 16:45:41,756 - jwst.assign_wcs.util - INFO - Excluding off-image object: 224, order 1
2025-09-13 16:45:41,838 - jwst.assign_wcs.util - INFO - Excluding off-image object: 231, order 1
2025-09-13 16:45:42,035 - jwst.assign_wcs.util - INFO - Excluding off-image object: 248, order 1
2025-09-13 16:45:42,692 - jwst.assign_wcs.util - INFO - Excluding off-image object: 304, order 1
2025-09-13 16:45:42,705 - jwst.assign_wcs.util - INFO - Excluding off-image object: 305, order 1
2025-09-13 16:45:42,718 - jwst.assign_wcs.util - INFO - Excluding off-image object: 306, order 1
2025-09-13 16:45:42,930 - jwst.assign_wcs.util - INFO - Excluding off-image object: 324, order 1
2025-09-13 16:45:42,990 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 329 order: 1
2025-09-13 16:45:43,332 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 358 order: 1
2025-09-13 16:45:43,415 - jwst.assign_wcs.util - INFO - Excluding off-image object: 365, order 1
2025-09-13 16:45:43,475 - jwst.assign_wcs.util - INFO - Excluding off-image object: 370, order 1
2025-09-13 16:45:43,488 - jwst.assign_wcs.util - INFO - Excluding off-image object: 371, order 1
2025-09-13 16:45:44,358 - jwst.assign_wcs.util - INFO - Excluding off-image object: 445, order 1
2025-09-13 16:45:44,405 - jwst.assign_wcs.util - INFO - Excluding off-image object: 449, order 1
2025-09-13 16:45:44,637 - jwst.assign_wcs.util - INFO - Excluding off-image object: 469, order 1
2025-09-13 16:45:44,824 - jwst.assign_wcs.util - INFO - Excluding off-image object: 485, order 1
2025-09-13 16:45:44,989 - jwst.assign_wcs.util - INFO - Excluding off-image object: 499, order 1
2025-09-13 16:45:45,952 - jwst.assign_wcs.util - INFO - Excluding off-image object: 582, order 1
2025-09-13 16:45:46,176 - jwst.assign_wcs.util - INFO - Excluding off-image object: 601, order 1
2025-09-13 16:45:46,270 - jwst.assign_wcs.util - INFO - Excluding off-image object: 609, order 1
2025-09-13 16:45:46,282 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 610 order: 1
2025-09-13 16:45:46,715 - jwst.assign_wcs.util - INFO - Excluding off-image object: 647, order 1
2025-09-13 16:45:46,868 - jwst.assign_wcs.util - INFO - Excluding off-image object: 660, order 1
2025-09-13 16:45:46,987 - jwst.assign_wcs.util - INFO - Excluding off-image object: 670, order 1
2025-09-13 16:45:47,023 - jwst.assign_wcs.util - INFO - Excluding off-image object: 673, order 1
2025-09-13 16:45:47,295 - jwst.assign_wcs.util - INFO - Excluding off-image object: 696, order 1
2025-09-13 16:45:47,332 - jwst.assign_wcs.util - INFO - Excluding off-image object: 699, order 1
2025-09-13 16:45:47,529 - jwst.assign_wcs.util - INFO - Excluding off-image object: 716, order 1
2025-09-13 16:45:47,623 - jwst.assign_wcs.util - INFO - Excluding off-image object: 724, order 1
2025-09-13 16:45:47,764 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 736 order: 1
2025-09-13 16:45:47,788 - jwst.assign_wcs.util - INFO - Excluding off-image object: 738, order 1
2025-09-13 16:45:47,835 - jwst.assign_wcs.util - INFO - Excluding off-image object: 742, order 1
2025-09-13 16:45:47,847 - jwst.assign_wcs.util - INFO - Excluding off-image object: 743, order 1
2025-09-13 16:45:48,046 - jwst.assign_wcs.util - INFO - Excluding off-image object: 760, order 1
2025-09-13 16:45:48,859 - jwst.assign_wcs.util - INFO - Excluding off-image object: 830, order 1
2025-09-13 16:45:48,898 - jwst.assign_wcs.util - INFO - Excluding off-image object: 833, order 1
2025-09-13 16:45:49,026 - jwst.assign_wcs.util - INFO - Excluding off-image object: 844, order 1
2025-09-13 16:45:49,144 - jwst.assign_wcs.util - INFO - Excluding off-image object: 854, order 1
2025-09-13 16:45:49,422 - jwst.assign_wcs.util - INFO - Excluding off-image object: 878, order 1
2025-09-13 16:45:49,608 - jwst.assign_wcs.util - INFO - Excluding off-image object: 894, order 1
2025-09-13 16:45:49,701 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 902 order: 1
2025-09-13 16:45:49,879 - jwst.assign_wcs.util - INFO - Excluding off-image object: 917, order 1
2025-09-13 16:45:49,915 - jwst.assign_wcs.util - INFO - Excluding off-image object: 920, order 1
2025-09-13 16:45:50,262 - jwst.assign_wcs.util - INFO - Excluding off-image object: 949, order 1
2025-09-13 16:45:50,324 - jwst.assign_wcs.util - INFO - Excluding off-image object: 954, order 1
2025-09-13 16:45:50,713 - jwst.assign_wcs.util - INFO - Excluding off-image object: 986, order 1
2025-09-13 16:45:50,811 - jwst.assign_wcs.util - INFO - Excluding off-image object: 994, order 1
2025-09-13 16:45:50,896 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1001, order 1
2025-09-13 16:45:51,015 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1011, order 1
2025-09-13 16:45:51,064 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1015, order 1
2025-09-13 16:45:51,101 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1018, order 1
2025-09-13 16:45:51,126 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1020 order: 1
2025-09-13 16:45:51,293 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1034, order 1
2025-09-13 16:45:51,472 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1049 order: 1
2025-09-13 16:45:51,496 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1051, order 1
2025-09-13 16:45:51,939 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1089, order 1
2025-09-13 16:45:51,986 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1093, order 1
2025-09-13 16:45:52,033 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1097, order 1
2025-09-13 16:45:52,104 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1103, order 1
2025-09-13 16:45:52,186 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1110, order 1
2025-09-13 16:45:52,698 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1154, order 1
2025-09-13 16:45:52,734 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1157, order 1
2025-09-13 16:45:52,873 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1169, order 1
2025-09-13 16:45:52,921 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1173, order 1
2025-09-13 16:45:52,991 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1179, order 1
2025-09-13 16:45:53,259 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1202, order 1
2025-09-13 16:45:53,296 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1205, order 1
2025-09-13 16:45:53,367 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1211, order 1
2025-09-13 16:45:53,511 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1223, order 1
2025-09-13 16:45:53,571 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1228, order 1
2025-09-13 16:45:53,632 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1233, order 1
2025-09-13 16:45:54,258 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1286, order 1
2025-09-13 16:45:54,650 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1320, order 1
2025-09-13 16:45:54,686 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1323, order 1
2025-09-13 16:45:55,339 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1379, order 1
2025-09-13 16:45:55,410 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1385, order 1
2025-09-13 16:45:55,881 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1425, order 1
2025-09-13 16:45:56,074 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1441, order 1
2025-09-13 16:45:56,492 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1476 order: 1
2025-09-13 16:45:56,528 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1479 order: 1
2025-09-13 16:45:56,553 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1481 order: 1
2025-09-13 16:45:56,565 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1482 order: 1
2025-09-13 16:45:56,578 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1483 order: 1
2025-09-13 16:45:56,590 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1484 order: 1
2025-09-13 16:45:56,603 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1485 order: 1
2025-09-13 16:45:56,615 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1486 order: 1
2025-09-13 16:45:56,627 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1487, order 1
2025-09-13 16:45:56,640 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1488 order: 1
2025-09-13 16:45:56,652 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1489 order: 1
2025-09-13 16:45:56,665 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1490 order: 1
2025-09-13 16:45:56,677 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1491 order: 1
2025-09-13 16:45:56,689 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1492 order: 1
2025-09-13 16:45:56,702 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1493 order: 1
2025-09-13 16:45:56,715 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1494 order: 1
2025-09-13 16:45:56,728 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1495 order: 1
2025-09-13 16:45:56,741 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1496 order: 1
2025-09-13 16:45:56,754 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1497 order: 1
2025-09-13 16:45:56,767 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1498 order: 1
2025-09-13 16:45:56,780 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1499 order: 1
2025-09-13 16:45:56,792 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1500 order: 1
2025-09-13 16:45:56,805 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1501 order: 1
2025-09-13 16:45:56,818 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1502 order: 1
2025-09-13 16:45:56,819 - jwst.assign_wcs.util - INFO - Total of 1304 grism objects defined
2025-09-13 16:45:56,859 - jwst.background.background_sub_wfss - INFO - Starting iterative outlier rejection for background subtraction.
2025-09-13 16:45:57,404 - jwst.background.background_sub_wfss - INFO - Stopped at maxiter (5).
2025-09-13 16:45:57,582 - jwst.background.background_sub_wfss - INFO - Average of scaled background image = 4.451e-01
2025-09-13 16:45:57,583 - jwst.background.background_sub_wfss - INFO - Scaling factor = 4.64082e-01
2025-09-13 16:45:57,589 - stpipe.Spec2Pipeline.bkg_subtract - INFO - Step bkg_subtract done
2025-09-13 16:45:58,019 - stpipe.Spec2Pipeline.flat_field - INFO - Step flat_field running with args (<ImageModel(2048, 2048) from jw02079004003_03101_00002_nis_rate.fits>,).
2025-09-13 16:45:58,094 - stpipe.Spec2Pipeline.flat_field - INFO - Using FLAT reference file: /home/runner/crds/references/jwst/niriss/jwst_niriss_flat_0271.fits
2025-09-13 16:45:58,095 - stpipe.Spec2Pipeline.flat_field - INFO - No reference found for type FFLAT
2025-09-13 16:45:58,095 - stpipe.Spec2Pipeline.flat_field - INFO - No reference found for type SFLAT
2025-09-13 16:45:58,095 - stpipe.Spec2Pipeline.flat_field - INFO - No reference found for type DFLAT
2025-09-13 16:45:58,314 - stpipe.Spec2Pipeline.flat_field - INFO - Step flat_field done
2025-09-13 16:45:58,731 - stpipe.Spec2Pipeline.extract_2d - INFO - Step extract_2d running with args (<ImageModel(2048, 2048) from jw02079004003_03101_00002_nis_rate.fits>,).
2025-09-13 16:45:58,742 - jwst.extract_2d.extract_2d - INFO - EXP_TYPE is NIS_WFSS
2025-09-13 16:45:58,753 - jwst.assign_wcs.util - INFO - Getting objects from jw02079-o004_niriss_clear-f200w_cat.ecsv
2025-09-13 16:45:59,062 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1, order 1
2025-09-13 16:45:59,074 - jwst.assign_wcs.util - INFO - Excluding off-image object: 2, order 1
2025-09-13 16:45:59,083 - jwst.assign_wcs.util - INFO - Excluding off-image object: 3, order 1
2025-09-13 16:45:59,095 - jwst.assign_wcs.util - INFO - Excluding off-image object: 4, order 1
2025-09-13 16:45:59,107 - jwst.assign_wcs.util - INFO - Excluding off-image object: 5, order 1
2025-09-13 16:45:59,119 - jwst.assign_wcs.util - INFO - Excluding off-image object: 6, order 1
2025-09-13 16:45:59,131 - jwst.assign_wcs.util - INFO - Excluding off-image object: 7, order 1
2025-09-13 16:45:59,143 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 8 order: 1
2025-09-13 16:45:59,155 - jwst.assign_wcs.util - INFO - Excluding off-image object: 9, order 1
2025-09-13 16:45:59,167 - jwst.assign_wcs.util - INFO - Excluding off-image object: 10, order 1
2025-09-13 16:45:59,179 - jwst.assign_wcs.util - INFO - Excluding off-image object: 11, order 1
2025-09-13 16:45:59,192 - jwst.assign_wcs.util - INFO - Excluding off-image object: 12, order 1
2025-09-13 16:45:59,204 - jwst.assign_wcs.util - INFO - Excluding off-image object: 13, order 1
2025-09-13 16:45:59,216 - jwst.assign_wcs.util - INFO - Excluding off-image object: 14, order 1
2025-09-13 16:45:59,228 - jwst.assign_wcs.util - INFO - Excluding off-image object: 15, order 1
2025-09-13 16:45:59,239 - jwst.assign_wcs.util - INFO - Excluding off-image object: 16, order 1
2025-09-13 16:45:59,251 - jwst.assign_wcs.util - INFO - Excluding off-image object: 17, order 1
2025-09-13 16:45:59,263 - jwst.assign_wcs.util - INFO - Excluding off-image object: 18, order 1
2025-09-13 16:45:59,275 - jwst.assign_wcs.util - INFO - Excluding off-image object: 19, order 1
2025-09-13 16:45:59,287 - jwst.assign_wcs.util - INFO - Excluding off-image object: 20, order 1
2025-09-13 16:45:59,299 - jwst.assign_wcs.util - INFO - Excluding off-image object: 21, order 1
2025-09-13 16:45:59,311 - jwst.assign_wcs.util - INFO - Excluding off-image object: 22, order 1
2025-09-13 16:45:59,323 - jwst.assign_wcs.util - INFO - Excluding off-image object: 23, order 1
2025-09-13 16:45:59,335 - jwst.assign_wcs.util - INFO - Excluding off-image object: 24, order 1
2025-09-13 16:45:59,347 - jwst.assign_wcs.util - INFO - Excluding off-image object: 25, order 1
2025-09-13 16:45:59,356 - jwst.assign_wcs.util - INFO - Excluding off-image object: 26, order 1
2025-09-13 16:45:59,368 - jwst.assign_wcs.util - INFO - Excluding off-image object: 27, order 1
2025-09-13 16:45:59,380 - jwst.assign_wcs.util - INFO - Excluding off-image object: 28, order 1
2025-09-13 16:45:59,392 - jwst.assign_wcs.util - INFO - Excluding off-image object: 29, order 1
2025-09-13 16:45:59,404 - jwst.assign_wcs.util - INFO - Excluding off-image object: 30, order 1
2025-09-13 16:45:59,413 - jwst.assign_wcs.util - INFO - Excluding off-image object: 31, order 1
2025-09-13 16:45:59,425 - jwst.assign_wcs.util - INFO - Excluding off-image object: 32, order 1
2025-09-13 16:45:59,434 - jwst.assign_wcs.util - INFO - Excluding off-image object: 33, order 1
2025-09-13 16:45:59,446 - jwst.assign_wcs.util - INFO - Excluding off-image object: 34, order 1
2025-09-13 16:45:59,458 - jwst.assign_wcs.util - INFO - Excluding off-image object: 35, order 1
2025-09-13 16:45:59,468 - jwst.assign_wcs.util - INFO - Excluding off-image object: 36, order 1
2025-09-13 16:45:59,480 - jwst.assign_wcs.util - INFO - Excluding off-image object: 37, order 1
2025-09-13 16:45:59,490 - jwst.assign_wcs.util - INFO - Excluding off-image object: 38, order 1
2025-09-13 16:45:59,502 - jwst.assign_wcs.util - INFO - Excluding off-image object: 39, order 1
2025-09-13 16:45:59,514 - jwst.assign_wcs.util - INFO - Excluding off-image object: 40, order 1
2025-09-13 16:45:59,526 - jwst.assign_wcs.util - INFO - Excluding off-image object: 41, order 1
2025-09-13 16:45:59,536 - jwst.assign_wcs.util - INFO - Excluding off-image object: 42, order 1
2025-09-13 16:45:59,544 - jwst.assign_wcs.util - INFO - Excluding off-image object: 43, order 1
2025-09-13 16:45:59,556 - jwst.assign_wcs.util - INFO - Excluding off-image object: 44, order 1
2025-09-13 16:45:59,568 - jwst.assign_wcs.util - INFO - Excluding off-image object: 45, order 1
2025-09-13 16:45:59,577 - jwst.assign_wcs.util - INFO - Excluding off-image object: 46, order 1
2025-09-13 16:45:59,589 - jwst.assign_wcs.util - INFO - Excluding off-image object: 47, order 1
2025-09-13 16:45:59,598 - jwst.assign_wcs.util - INFO - Excluding off-image object: 48, order 1
2025-09-13 16:45:59,611 - jwst.assign_wcs.util - INFO - Excluding off-image object: 49, order 1
2025-09-13 16:45:59,620 - jwst.assign_wcs.util - INFO - Excluding off-image object: 50, order 1
2025-09-13 16:45:59,629 - jwst.assign_wcs.util - INFO - Excluding off-image object: 51, order 1
2025-09-13 16:45:59,638 - jwst.assign_wcs.util - INFO - Excluding off-image object: 52, order 1
2025-09-13 16:45:59,647 - jwst.assign_wcs.util - INFO - Excluding off-image object: 53, order 1
2025-09-13 16:45:59,659 - jwst.assign_wcs.util - INFO - Excluding off-image object: 54, order 1
2025-09-13 16:45:59,668 - jwst.assign_wcs.util - INFO - Excluding off-image object: 55, order 1
2025-09-13 16:45:59,678 - jwst.assign_wcs.util - INFO - Excluding off-image object: 56, order 1
2025-09-13 16:45:59,690 - jwst.assign_wcs.util - INFO - Excluding off-image object: 57, order 1
2025-09-13 16:45:59,703 - jwst.assign_wcs.util - INFO - Excluding off-image object: 58, order 1
2025-09-13 16:45:59,712 - jwst.assign_wcs.util - INFO - Excluding off-image object: 59, order 1
2025-09-13 16:45:59,724 - jwst.assign_wcs.util - INFO - Excluding off-image object: 60, order 1
2025-09-13 16:45:59,733 - jwst.assign_wcs.util - INFO - Excluding off-image object: 61, order 1
2025-09-13 16:45:59,743 - jwst.assign_wcs.util - INFO - Excluding off-image object: 62, order 1
2025-09-13 16:45:59,755 - jwst.assign_wcs.util - INFO - Excluding off-image object: 63, order 1
2025-09-13 16:45:59,767 - jwst.assign_wcs.util - INFO - Excluding off-image object: 64, order 1
2025-09-13 16:45:59,776 - jwst.assign_wcs.util - INFO - Excluding off-image object: 65, order 1
2025-09-13 16:45:59,788 - jwst.assign_wcs.util - INFO - Excluding off-image object: 66, order 1
2025-09-13 16:45:59,797 - jwst.assign_wcs.util - INFO - Excluding off-image object: 67, order 1
2025-09-13 16:45:59,806 - jwst.assign_wcs.util - INFO - Excluding off-image object: 68, order 1
2025-09-13 16:45:59,818 - jwst.assign_wcs.util - INFO - Excluding off-image object: 69, order 1
2025-09-13 16:45:59,830 - jwst.assign_wcs.util - INFO - Excluding off-image object: 70, order 1
2025-09-13 16:45:59,842 - jwst.assign_wcs.util - INFO - Excluding off-image object: 71, order 1
2025-09-13 16:45:59,851 - jwst.assign_wcs.util - INFO - Excluding off-image object: 72, order 1
2025-09-13 16:45:59,860 - jwst.assign_wcs.util - INFO - Excluding off-image object: 73, order 1
2025-09-13 16:45:59,869 - jwst.assign_wcs.util - INFO - Excluding off-image object: 74, order 1
2025-09-13 16:45:59,879 - jwst.assign_wcs.util - INFO - Excluding off-image object: 75, order 1
2025-09-13 16:45:59,888 - jwst.assign_wcs.util - INFO - Excluding off-image object: 76, order 1
2025-09-13 16:45:59,900 - jwst.assign_wcs.util - INFO - Excluding off-image object: 77, order 1
2025-09-13 16:45:59,911 - jwst.assign_wcs.util - INFO - Excluding off-image object: 78, order 1
2025-09-13 16:45:59,921 - jwst.assign_wcs.util - INFO - Excluding off-image object: 79, order 1
2025-09-13 16:45:59,933 - jwst.assign_wcs.util - INFO - Excluding off-image object: 80, order 1
2025-09-13 16:45:59,942 - jwst.assign_wcs.util - INFO - Excluding off-image object: 81, order 1
2025-09-13 16:45:59,951 - jwst.assign_wcs.util - INFO - Excluding off-image object: 82, order 1
2025-09-13 16:45:59,963 - jwst.assign_wcs.util - INFO - Excluding off-image object: 83, order 1
2025-09-13 16:45:59,973 - jwst.assign_wcs.util - INFO - Excluding off-image object: 84, order 1
2025-09-13 16:45:59,982 - jwst.assign_wcs.util - INFO - Excluding off-image object: 85, order 1
2025-09-13 16:45:59,991 - jwst.assign_wcs.util - INFO - Excluding off-image object: 86, order 1
2025-09-13 16:46:00,003 - jwst.assign_wcs.util - INFO - Excluding off-image object: 87, order 1
2025-09-13 16:46:00,013 - jwst.assign_wcs.util - INFO - Excluding off-image object: 88, order 1
2025-09-13 16:46:00,024 - jwst.assign_wcs.util - INFO - Excluding off-image object: 89, order 1
2025-09-13 16:46:00,036 - jwst.assign_wcs.util - INFO - Excluding off-image object: 90, order 1
2025-09-13 16:46:00,045 - jwst.assign_wcs.util - INFO - Excluding off-image object: 91, order 1
2025-09-13 16:46:00,057 - jwst.assign_wcs.util - INFO - Excluding off-image object: 92, order 1
2025-09-13 16:46:00,066 - jwst.assign_wcs.util - INFO - Excluding off-image object: 93, order 1
2025-09-13 16:46:00,075 - jwst.assign_wcs.util - INFO - Excluding off-image object: 94, order 1
2025-09-13 16:46:00,084 - jwst.assign_wcs.util - INFO - Excluding off-image object: 95, order 1
2025-09-13 16:46:00,096 - jwst.assign_wcs.util - INFO - Excluding off-image object: 96, order 1
2025-09-13 16:46:00,108 - jwst.assign_wcs.util - INFO - Excluding off-image object: 97, order 1
2025-09-13 16:46:00,117 - jwst.assign_wcs.util - INFO - Excluding off-image object: 98, order 1
2025-09-13 16:46:00,126 - jwst.assign_wcs.util - INFO - Excluding off-image object: 99, order 1
2025-09-13 16:46:00,135 - jwst.assign_wcs.util - INFO - Excluding off-image object: 100, order 1
2025-09-13 16:46:00,144 - jwst.assign_wcs.util - INFO - Excluding off-image object: 101, order 1
2025-09-13 16:46:00,153 - jwst.assign_wcs.util - INFO - Excluding off-image object: 102, order 1
2025-09-13 16:46:00,162 - jwst.assign_wcs.util - INFO - Excluding off-image object: 103, order 1
2025-09-13 16:46:00,171 - jwst.assign_wcs.util - INFO - Excluding off-image object: 104, order 1
2025-09-13 16:46:00,185 - jwst.assign_wcs.util - INFO - Excluding off-image object: 105, order 1
2025-09-13 16:46:00,194 - jwst.assign_wcs.util - INFO - Excluding off-image object: 106, order 1
2025-09-13 16:46:00,203 - jwst.assign_wcs.util - INFO - Excluding off-image object: 107, order 1
2025-09-13 16:46:00,215 - jwst.assign_wcs.util - INFO - Excluding off-image object: 108, order 1
2025-09-13 16:46:00,225 - jwst.assign_wcs.util - INFO - Excluding off-image object: 109, order 1
2025-09-13 16:46:00,237 - jwst.assign_wcs.util - INFO - Excluding off-image object: 110, order 1
2025-09-13 16:46:00,246 - jwst.assign_wcs.util - INFO - Excluding off-image object: 111, order 1
2025-09-13 16:46:00,256 - jwst.assign_wcs.util - INFO - Excluding off-image object: 112, order 1
2025-09-13 16:46:00,265 - jwst.assign_wcs.util - INFO - Excluding off-image object: 113, order 1
2025-09-13 16:46:00,274 - jwst.assign_wcs.util - INFO - Excluding off-image object: 114, order 1
2025-09-13 16:46:00,283 - jwst.assign_wcs.util - INFO - Excluding off-image object: 115, order 1
2025-09-13 16:46:00,292 - jwst.assign_wcs.util - INFO - Excluding off-image object: 116, order 1
2025-09-13 16:46:00,301 - jwst.assign_wcs.util - INFO - Excluding off-image object: 117, order 1
2025-09-13 16:46:00,311 - jwst.assign_wcs.util - INFO - Excluding off-image object: 118, order 1
2025-09-13 16:46:00,320 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 119 order: 1
2025-09-13 16:46:00,332 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 120 order: 1
2025-09-13 16:46:00,341 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 121 order: 1
2025-09-13 16:46:00,353 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 122 order: 1
2025-09-13 16:46:00,362 - jwst.assign_wcs.util - INFO - Excluding off-image object: 123, order 1
2025-09-13 16:46:00,371 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 124 order: 1
2025-09-13 16:46:00,380 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 125 order: 1
2025-09-13 16:46:00,389 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 126 order: 1
2025-09-13 16:46:00,398 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 127 order: 1
2025-09-13 16:46:00,407 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 128 order: 1
2025-09-13 16:46:00,419 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 129 order: 1
2025-09-13 16:46:00,428 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 130 order: 1
2025-09-13 16:46:00,437 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 131 order: 1
2025-09-13 16:46:00,446 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 132 order: 1
2025-09-13 16:46:00,455 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 133 order: 1
2025-09-13 16:46:00,464 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 134 order: 1
2025-09-13 16:46:00,473 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 135 order: 1
2025-09-13 16:46:00,485 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 136 order: 1
2025-09-13 16:46:00,496 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 137 order: 1
2025-09-13 16:46:00,508 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 138 order: 1
2025-09-13 16:46:00,520 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 139 order: 1
2025-09-13 16:46:00,529 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 140 order: 1
2025-09-13 16:46:00,538 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 141 order: 1
2025-09-13 16:46:00,550 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 142 order: 1
2025-09-13 16:46:00,559 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 143 order: 1
2025-09-13 16:46:00,570 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 144 order: 1
2025-09-13 16:46:00,582 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 145 order: 1
2025-09-13 16:46:00,591 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 146 order: 1
2025-09-13 16:46:00,603 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 147 order: 1
2025-09-13 16:46:00,612 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 148 order: 1
2025-09-13 16:46:00,621 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 149 order: 1
2025-09-13 16:46:00,630 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 150 order: 1
2025-09-13 16:46:00,639 - jwst.assign_wcs.util - INFO - Excluding off-image object: 151, order 1
2025-09-13 16:46:00,650 - jwst.assign_wcs.util - INFO - Excluding off-image object: 152, order 1
2025-09-13 16:46:00,663 - jwst.assign_wcs.util - INFO - Excluding off-image object: 153, order 1
2025-09-13 16:46:00,671 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 154 order: 1
2025-09-13 16:46:00,683 - jwst.assign_wcs.util - INFO - Excluding off-image object: 155, order 1
2025-09-13 16:46:00,692 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 156 order: 1
2025-09-13 16:46:00,701 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 157 order: 1
2025-09-13 16:46:00,710 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 158 order: 1
2025-09-13 16:46:00,719 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 159 order: 1
2025-09-13 16:46:00,728 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 160 order: 1
2025-09-13 16:46:00,737 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 161 order: 1
2025-09-13 16:46:00,747 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 162 order: 1
2025-09-13 16:46:00,756 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 163 order: 1
2025-09-13 16:46:00,767 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 164 order: 1
2025-09-13 16:46:00,779 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 165 order: 1
2025-09-13 16:46:00,789 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 166 order: 1
2025-09-13 16:46:00,801 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 167 order: 1
2025-09-13 16:46:00,810 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 168 order: 1
2025-09-13 16:46:00,819 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 169 order: 1
2025-09-13 16:46:00,828 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 170 order: 1
2025-09-13 16:46:00,837 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 171 order: 1
2025-09-13 16:46:00,846 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 172 order: 1
2025-09-13 16:46:00,858 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 173 order: 1
2025-09-13 16:46:00,867 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 174 order: 1
2025-09-13 16:46:00,877 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 175 order: 1
2025-09-13 16:46:00,890 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 176 order: 1
2025-09-13 16:46:00,899 - jwst.assign_wcs.util - INFO - Excluding off-image object: 177, order 1
2025-09-13 16:46:00,908 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 178 order: 1
2025-09-13 16:46:00,917 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 179 order: 1
2025-09-13 16:46:00,926 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 180 order: 1
2025-09-13 16:46:00,938 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 181 order: 1
2025-09-13 16:46:00,949 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 182 order: 1
2025-09-13 16:46:00,958 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 183 order: 1
2025-09-13 16:46:00,970 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 184 order: 1
2025-09-13 16:46:00,979 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 185 order: 1
2025-09-13 16:46:00,991 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 186 order: 1
2025-09-13 16:46:01,000 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 187 order: 1
2025-09-13 16:46:01,009 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 188 order: 1
2025-09-13 16:46:01,018 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 189 order: 1
2025-09-13 16:46:01,030 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 190 order: 1
2025-09-13 16:46:01,039 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 191 order: 1
2025-09-13 16:46:01,047 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 192 order: 1
2025-09-13 16:46:01,056 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 193 order: 1
2025-09-13 16:46:01,074 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 195 order: 1
2025-09-13 16:46:01,092 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 197 order: 1
2025-09-13 16:46:01,101 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 198 order: 1
2025-09-13 16:46:01,146 - jwst.assign_wcs.util - INFO - Excluding off-image object: 203, order 1
2025-09-13 16:46:01,183 - jwst.assign_wcs.util - INFO - Excluding off-image object: 207, order 1
2025-09-13 16:46:01,297 - jwst.assign_wcs.util - INFO - Excluding off-image object: 219, order 1
2025-09-13 16:46:01,350 - jwst.assign_wcs.util - INFO - Excluding off-image object: 224, order 1
2025-09-13 16:46:01,416 - jwst.assign_wcs.util - INFO - Excluding off-image object: 231, order 1
2025-09-13 16:46:01,569 - jwst.assign_wcs.util - INFO - Excluding off-image object: 248, order 1
2025-09-13 16:46:02,077 - jwst.assign_wcs.util - INFO - Excluding off-image object: 304, order 1
2025-09-13 16:46:02,089 - jwst.assign_wcs.util - INFO - Excluding off-image object: 305, order 1
2025-09-13 16:46:02,101 - jwst.assign_wcs.util - INFO - Excluding off-image object: 306, order 1
2025-09-13 16:46:02,262 - jwst.assign_wcs.util - INFO - Excluding off-image object: 324, order 1
2025-09-13 16:46:02,311 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 329 order: 1
2025-09-13 16:46:02,584 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 358 order: 1
2025-09-13 16:46:02,647 - jwst.assign_wcs.util - INFO - Excluding off-image object: 365, order 1
2025-09-13 16:46:02,699 - jwst.assign_wcs.util - INFO - Excluding off-image object: 370, order 1
2025-09-13 16:46:02,711 - jwst.assign_wcs.util - INFO - Excluding off-image object: 371, order 1
2025-09-13 16:46:03,396 - jwst.assign_wcs.util - INFO - Excluding off-image object: 445, order 1
2025-09-13 16:46:03,430 - jwst.assign_wcs.util - INFO - Excluding off-image object: 449, order 1
2025-09-13 16:46:03,620 - jwst.assign_wcs.util - INFO - Excluding off-image object: 469, order 1
2025-09-13 16:46:03,764 - jwst.assign_wcs.util - INFO - Excluding off-image object: 485, order 1
2025-09-13 16:46:03,890 - jwst.assign_wcs.util - INFO - Excluding off-image object: 499, order 1
2025-09-13 16:46:04,648 - jwst.assign_wcs.util - INFO - Excluding off-image object: 582, order 1
2025-09-13 16:46:04,831 - jwst.assign_wcs.util - INFO - Excluding off-image object: 601, order 1
2025-09-13 16:46:04,910 - jwst.assign_wcs.util - INFO - Excluding off-image object: 609, order 1
2025-09-13 16:46:04,923 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 610 order: 1
2025-09-13 16:46:05,271 - jwst.assign_wcs.util - INFO - Excluding off-image object: 647, order 1
2025-09-13 16:46:05,394 - jwst.assign_wcs.util - INFO - Excluding off-image object: 660, order 1
2025-09-13 16:46:05,495 - jwst.assign_wcs.util - INFO - Excluding off-image object: 670, order 1
2025-09-13 16:46:05,521 - jwst.assign_wcs.util - INFO - Excluding off-image object: 673, order 1
2025-09-13 16:46:05,727 - jwst.assign_wcs.util - INFO - Excluding off-image object: 696, order 1
2025-09-13 16:46:05,757 - jwst.assign_wcs.util - INFO - Excluding off-image object: 699, order 1
2025-09-13 16:46:05,914 - jwst.assign_wcs.util - INFO - Excluding off-image object: 716, order 1
2025-09-13 16:46:05,985 - jwst.assign_wcs.util - INFO - Excluding off-image object: 724, order 1
2025-09-13 16:46:06,092 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 736 order: 1
2025-09-13 16:46:06,114 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 738 order: 1
2025-09-13 16:46:06,149 - jwst.assign_wcs.util - INFO - Excluding off-image object: 742, order 1
2025-09-13 16:46:06,158 - jwst.assign_wcs.util - INFO - Excluding off-image object: 743, order 1
2025-09-13 16:46:06,308 - jwst.assign_wcs.util - INFO - Excluding off-image object: 760, order 1
2025-09-13 16:46:06,932 - jwst.assign_wcs.util - INFO - Excluding off-image object: 830, order 1
2025-09-13 16:46:06,960 - jwst.assign_wcs.util - INFO - Excluding off-image object: 833, order 1
2025-09-13 16:46:07,058 - jwst.assign_wcs.util - INFO - Excluding off-image object: 844, order 1
2025-09-13 16:46:07,149 - jwst.assign_wcs.util - INFO - Excluding off-image object: 854, order 1
2025-09-13 16:46:07,378 - jwst.assign_wcs.util - INFO - Excluding off-image object: 878, order 1
2025-09-13 16:46:07,525 - jwst.assign_wcs.util - INFO - Excluding off-image object: 894, order 1
2025-09-13 16:46:07,598 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 902 order: 1
2025-09-13 16:46:07,730 - jwst.assign_wcs.util - INFO - Excluding off-image object: 917, order 1
2025-09-13 16:46:07,755 - jwst.assign_wcs.util - INFO - Excluding off-image object: 920, order 1
2025-09-13 16:46:08,010 - jwst.assign_wcs.util - INFO - Excluding off-image object: 949, order 1
2025-09-13 16:46:08,058 - jwst.assign_wcs.util - INFO - Excluding off-image object: 954, order 1
2025-09-13 16:46:08,340 - jwst.assign_wcs.util - INFO - Excluding off-image object: 986, order 1
2025-09-13 16:46:08,410 - jwst.assign_wcs.util - INFO - Excluding off-image object: 994, order 1
2025-09-13 16:46:08,473 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1001, order 1
2025-09-13 16:46:08,564 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1011, order 1
2025-09-13 16:46:08,602 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1015, order 1
2025-09-13 16:46:08,631 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1018, order 1
2025-09-13 16:46:08,649 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1020 order: 1
2025-09-13 16:46:08,781 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1034, order 1
2025-09-13 16:46:08,918 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1049 order: 1
2025-09-13 16:46:08,938 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1051, order 1
2025-09-13 16:46:09,283 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1089, order 1
2025-09-13 16:46:09,323 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1093, order 1
2025-09-13 16:46:09,362 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1097, order 1
2025-09-13 16:46:09,417 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1103, order 1
2025-09-13 16:46:09,488 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1110, order 1
2025-09-13 16:46:09,880 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1154, order 1
2025-09-13 16:46:09,912 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1157, order 1
2025-09-13 16:46:10,020 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1169, order 1
2025-09-13 16:46:10,054 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1173, order 1
2025-09-13 16:46:10,108 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1179, order 1
2025-09-13 16:46:10,312 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1202, order 1
2025-09-13 16:46:10,340 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1205, order 1
2025-09-13 16:46:10,396 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1211, order 1
2025-09-13 16:46:10,508 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1223, order 1
2025-09-13 16:46:10,554 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1228, order 1
2025-09-13 16:46:10,599 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1233, order 1
2025-09-13 16:46:11,080 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1286, order 1
2025-09-13 16:46:11,394 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1320, order 1
2025-09-13 16:46:11,427 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1323, order 1
2025-09-13 16:46:11,949 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1379, order 1
2025-09-13 16:46:12,006 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1385, order 1
2025-09-13 16:46:12,378 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1425, order 1
2025-09-13 16:46:12,525 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1441, order 1
2025-09-13 16:46:12,849 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1476 order: 1
2025-09-13 16:46:12,877 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1479 order: 1
2025-09-13 16:46:12,894 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1481 order: 1
2025-09-13 16:46:12,903 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1482 order: 1
2025-09-13 16:46:12,912 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1483 order: 1
2025-09-13 16:46:12,921 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1484 order: 1
2025-09-13 16:46:12,932 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1485 order: 1
2025-09-13 16:46:12,941 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1486 order: 1
2025-09-13 16:46:12,950 - jwst.assign_wcs.util - INFO - Excluding off-image object: 1487, order 1
2025-09-13 16:46:12,959 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1488 order: 1
2025-09-13 16:46:12,971 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1489 order: 1
2025-09-13 16:46:12,983 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1490 order: 1
2025-09-13 16:46:12,992 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1491 order: 1
2025-09-13 16:46:13,001 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1492 order: 1
2025-09-13 16:46:13,009 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1493 order: 1
2025-09-13 16:46:13,018 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1494 order: 1
2025-09-13 16:46:13,027 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1495 order: 1
2025-09-13 16:46:13,036 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1496 order: 1
2025-09-13 16:46:13,045 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1497 order: 1
2025-09-13 16:46:13,053 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1498 order: 1
2025-09-13 16:46:13,062 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1499 order: 1
2025-09-13 16:46:13,074 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1500 order: 1
2025-09-13 16:46:13,086 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1501 order: 1
2025-09-13 16:46:13,097 - jwst.assign_wcs.util - INFO - Partial order on detector for obj: 1502 order: 1
2025-09-13 16:46:13,103 - jwst.assign_wcs.util - INFO - Total of 100 grism objects defined
2025-09-13 16:46:13,128 - jwst.extract_2d.grisms - INFO - Grism object list created from source catalog: jw02079-o004_niriss_clear-f200w_cat.ecsv
2025-09-13 16:46:13,130 - jwst.extract_2d.grisms - INFO - Extracting 100 grism objects
2025-09-13 16:46:13,238 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 8 order: 1:
2025-09-13 16:46:13,238 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1852, xmax:1862), (ymin:0, ymax:27)
2025-09-13 16:46:13,410 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 522 order: 1:
2025-09-13 16:46:13,410 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:631, xmax:777), (ymin:450, ymax:720)
2025-09-13 16:46:13,589 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 796 order: 1:
2025-09-13 16:46:13,590 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1810, xmax:1903), (ymin:874, ymax:1091)
2025-09-13 16:46:13,763 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 1479 order: 1:
2025-09-13 16:46:13,764 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:160, xmax:262), (ymin:1908, ymax:2048)
2025-09-13 16:46:13,931 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 214 order: 1:
2025-09-13 16:46:13,932 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:325, xmax:409), (ymin:24, ymax:251)
2025-09-13 16:46:14,107 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 693 order: 1:
2025-09-13 16:46:14,108 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:107, xmax:178), (ymin:706, ymax:904)
2025-09-13 16:46:14,280 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 1120 order: 1:
2025-09-13 16:46:14,281 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:526, xmax:635), (ymin:1332, ymax:1524)
2025-09-13 16:46:14,905 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 1257 order: 1:
2025-09-13 16:46:14,905 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1465, xmax:1568), (ymin:1525, ymax:1725)
2025-09-13 16:46:15,084 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 766 order: 1:
2025-09-13 16:46:15,084 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:967, xmax:1019), (ymin:832, ymax:1057)
2025-09-13 16:46:15,263 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 606 order: 1:
2025-09-13 16:46:15,263 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:456, xmax:466), (ymin:567, ymax:752)
2025-09-13 16:46:15,437 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 649 order: 1:
2025-09-13 16:46:15,438 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1551, xmax:1641), (ymin:634, ymax:851)
2025-09-13 16:46:15,615 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 982 order: 1:
2025-09-13 16:46:15,616 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:415, xmax:463), (ymin:1130, ymax:1308)
2025-09-13 16:46:15,787 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 1364 order: 1:
2025-09-13 16:46:15,788 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1376, xmax:1419), (ymin:1699, ymax:1883)
2025-09-13 16:46:15,960 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 898 order: 1:
2025-09-13 16:46:15,960 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1432, xmax:1442), (ymin:1016, ymax:1231)
2025-09-13 16:46:16,129 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 1049 order: 1:
2025-09-13 16:46:16,130 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:0, xmax:24), (ymin:1228, ymax:1427)
2025-09-13 16:46:16,304 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 732 order: 1:
2025-09-13 16:46:16,304 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:512, xmax:577), (ymin:775, ymax:942)
2025-09-13 16:46:16,476 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 189 order: 1:
2025-09-13 16:46:16,476 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1129, xmax:1176), (ymin:0, ymax:158)
2025-09-13 16:46:16,646 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 881 order: 1:
2025-09-13 16:46:16,647 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1164, xmax:1174), (ymin:986, ymax:1171)
2025-09-13 16:46:16,820 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 966 order: 1:
2025-09-13 16:46:16,821 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1400, xmax:1454), (ymin:1121, ymax:1303)
2025-09-13 16:46:16,996 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 914 order: 1:
2025-09-13 16:46:16,996 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1778, xmax:1821), (ymin:1041, ymax:1195)
2025-09-13 16:46:17,172 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 1084 order: 1:
2025-09-13 16:46:17,172 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1823, xmax:1833), (ymin:1292, ymax:1458)
2025-09-13 16:46:17,350 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 540 order: 1:
2025-09-13 16:46:17,351 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1694, xmax:1756), (ymin:477, ymax:670)
2025-09-13 16:46:17,527 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 1476 order: 1:
2025-09-13 16:46:17,528 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:0, xmax:49), (ymin:1906, ymax:2048)
2025-09-13 16:46:17,702 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 1142 order: 1:
2025-09-13 16:46:17,703 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:87, xmax:131), (ymin:1362, ymax:1532)
2025-09-13 16:46:17,878 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 220 order: 1:
2025-09-13 16:46:17,879 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:158, xmax:168), (ymin:34, ymax:207)
2025-09-13 16:46:18,053 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 289 order: 1:
2025-09-13 16:46:18,054 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1870, xmax:1918), (ymin:134, ymax:291)
2025-09-13 16:46:18,227 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 934 order: 1:
2025-09-13 16:46:18,227 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:694, xmax:743), (ymin:1067, ymax:1237)
2025-09-13 16:46:18,402 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 1219 order: 1:
2025-09-13 16:46:18,403 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:931, xmax:975), (ymin:1477, ymax:1661)
2025-09-13 16:46:18,576 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 927 order: 1:
2025-09-13 16:46:18,577 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:792, xmax:843), (ymin:1053, ymax:1220)
2025-09-13 16:46:18,749 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 1417 order: 1:
2025-09-13 16:46:18,749 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:143, xmax:182), (ymin:1795, ymax:1958)
2025-09-13 16:46:18,924 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 567 order: 1:
2025-09-13 16:46:18,925 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1658, xmax:1703), (ymin:524, ymax:695)
2025-09-13 16:46:19,102 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 1296 order: 1:
2025-09-13 16:46:19,103 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:636, xmax:678), (ymin:1580, ymax:1747)
2025-09-13 16:46:19,282 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 1412 order: 1:
2025-09-13 16:46:19,283 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:857, xmax:896), (ymin:1790, ymax:1953)
2025-09-13 16:46:19,463 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 654 order: 1:
2025-09-13 16:46:19,464 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1764, xmax:1829), (ymin:643, ymax:825)
2025-09-13 16:46:19,639 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 1029 order: 1:
2025-09-13 16:46:19,640 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:113, xmax:187), (ymin:1193, ymax:1373)
2025-09-13 16:46:19,817 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 553 order: 1:
2025-09-13 16:46:19,818 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:432, xmax:479), (ymin:493, ymax:651)
2025-09-13 16:46:20,563 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 1387 order: 1:
2025-09-13 16:46:20,564 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1986, xmax:2024), (ymin:1745, ymax:1909)
2025-09-13 16:46:20,739 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 422 order: 1:
2025-09-13 16:46:20,740 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1541, xmax:1573), (ymin:301, ymax:451)
2025-09-13 16:46:20,914 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 821 order: 1:
2025-09-13 16:46:20,915 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:107, xmax:144), (ymin:893, ymax:1059)
2025-09-13 16:46:21,092 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 682 order: 1:
2025-09-13 16:46:21,093 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:960, xmax:1002), (ymin:698, ymax:871)
2025-09-13 16:46:21,271 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 1140 order: 1:
2025-09-13 16:46:21,271 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1623, xmax:1670), (ymin:1368, ymax:1534)
2025-09-13 16:46:21,450 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 1388 order: 1:
2025-09-13 16:46:21,451 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1759, xmax:1809), (ymin:1746, ymax:1928)
2025-09-13 16:46:21,627 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 759 order: 1:
2025-09-13 16:46:21,628 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1157, xmax:1201), (ymin:823, ymax:986)
2025-09-13 16:46:21,805 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 1407 order: 1:
2025-09-13 16:46:21,805 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1254, xmax:1295), (ymin:1774, ymax:1933)
2025-09-13 16:46:21,980 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 1194 order: 1:
2025-09-13 16:46:21,980 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1678, xmax:1719), (ymin:1430, ymax:1583)
2025-09-13 16:46:22,153 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 712 order: 1:
2025-09-13 16:46:22,154 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1294, xmax:1335), (ymin:744, ymax:900)
2025-09-13 16:46:22,330 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 539 order: 1:
2025-09-13 16:46:22,331 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1604, xmax:1632), (ymin:476, ymax:641)
2025-09-13 16:46:22,502 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 1008 order: 1:
2025-09-13 16:46:22,503 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1017, xmax:1049), (ymin:1171, ymax:1326)
2025-09-13 16:46:22,678 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 347 order: 1:
2025-09-13 16:46:22,679 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:705, xmax:715), (ymin:198, ymax:356)
2025-09-13 16:46:22,855 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 276 order: 1:
2025-09-13 16:46:22,855 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1287, xmax:1330), (ymin:111, ymax:277)
2025-09-13 16:46:23,032 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 605 order: 1:
2025-09-13 16:46:23,033 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:333, xmax:343), (ymin:566, ymax:712)
2025-09-13 16:46:23,204 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 922 order: 1:
2025-09-13 16:46:23,204 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1705, xmax:1736), (ymin:1049, ymax:1202)
2025-09-13 16:46:23,377 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 736 order: 1:
2025-09-13 16:46:23,377 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:2028, xmax:2048), (ymin:788, ymax:933)
2025-09-13 16:46:23,550 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 1423 order: 1:
2025-09-13 16:46:23,551 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:199, xmax:232), (ymin:1816, ymax:1972)
2025-09-13 16:46:23,722 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 800 order: 1:
2025-09-13 16:46:23,723 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:783, xmax:810), (ymin:873, ymax:1023)
2025-09-13 16:46:23,893 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 873 order: 1:
2025-09-13 16:46:23,894 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1995, xmax:2018), (ymin:981, ymax:1131)
2025-09-13 16:46:24,069 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 385 order: 1:
2025-09-13 16:46:24,070 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:419, xmax:460), (ymin:243, ymax:387)
2025-09-13 16:46:24,242 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 557 order: 1:
2025-09-13 16:46:24,243 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:318, xmax:356), (ymin:505, ymax:666)
2025-09-13 16:46:24,418 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 719 order: 1:
2025-09-13 16:46:24,419 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1579, xmax:1603), (ymin:755, ymax:906)
2025-09-13 16:46:24,593 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 389 order: 1:
2025-09-13 16:46:24,594 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:475, xmax:507), (ymin:248, ymax:400)
2025-09-13 16:46:24,770 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 733 order: 1:
2025-09-13 16:46:24,770 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1847, xmax:1900), (ymin:783, ymax:949)
2025-09-13 16:46:24,950 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 1442 order: 1:
2025-09-13 16:46:24,950 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:673, xmax:717), (ymin:1850, ymax:2018)
2025-09-13 16:46:25,129 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 417 order: 1:
2025-09-13 16:46:25,129 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:928, xmax:954), (ymin:289, ymax:440)
2025-09-13 16:46:25,304 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 630 order: 1:
2025-09-13 16:46:25,305 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1898, xmax:1908), (ymin:601, ymax:738)
2025-09-13 16:46:25,480 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 925 order: 1:
2025-09-13 16:46:25,481 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:412, xmax:454), (ymin:1046, ymax:1202)
2025-09-13 16:46:25,656 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 527 order: 1:
2025-09-13 16:46:25,656 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1886, xmax:1914), (ymin:462, ymax:620)
2025-09-13 16:46:25,834 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 439 order: 1:
2025-09-13 16:46:25,834 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:802, xmax:812), (ymin:320, ymax:475)
2025-09-13 16:46:26,657 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 1253 order: 1:
2025-09-13 16:46:26,658 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:243, xmax:266), (ymin:1516, ymax:1673)
2025-09-13 16:46:26,835 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 1162 order: 1:
2025-09-13 16:46:26,835 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:923, xmax:943), (ymin:1388, ymax:1530)
2025-09-13 16:46:27,014 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 1457 order: 1:
2025-09-13 16:46:27,015 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:278, xmax:302), (ymin:1876, ymax:2025)
2025-09-13 16:46:27,191 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 694 order: 1:
2025-09-13 16:46:27,191 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:360, xmax:404), (ymin:707, ymax:852)
2025-09-13 16:46:27,370 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 1266 order: 1:
2025-09-13 16:46:27,371 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:826, xmax:862), (ymin:1538, ymax:1689)
2025-09-13 16:46:27,553 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 298 order: 1:
2025-09-13 16:46:27,554 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1157, xmax:1189), (ymin:140, ymax:285)
2025-09-13 16:46:27,731 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 516 order: 1:
2025-09-13 16:46:27,732 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:589, xmax:620), (ymin:442, ymax:599)
2025-09-13 16:46:27,909 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 973 order: 1:
2025-09-13 16:46:27,910 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:566, xmax:589), (ymin:1123, ymax:1267)
2025-09-13 16:46:28,087 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 180 order: 1:
2025-09-13 16:46:28,088 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1486, xmax:1529), (ymin:0, ymax:132)
2025-09-13 16:46:28,266 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 980 order: 1:
2025-09-13 16:46:28,267 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1472, xmax:1511), (ymin:1134, ymax:1287)
2025-09-13 16:46:28,445 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 263 order: 1:
2025-09-13 16:46:28,446 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:942, xmax:981), (ymin:83, ymax:230)
2025-09-13 16:46:28,622 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 493 order: 1:
2025-09-13 16:46:28,622 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1524, xmax:1554), (ymin:407, ymax:560)
2025-09-13 16:46:28,799 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 981 order: 1:
2025-09-13 16:46:28,800 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1842, xmax:1861), (ymin:1135, ymax:1281)
2025-09-13 16:46:28,977 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 1371 order: 1:
2025-09-13 16:46:28,977 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:741, xmax:765), (ymin:1707, ymax:1854)
2025-09-13 16:46:29,155 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 536 order: 1:
2025-09-13 16:46:29,156 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:492, xmax:515), (ymin:466, ymax:623)
2025-09-13 16:46:29,330 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 749 order: 1:
2025-09-13 16:46:29,330 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1599, xmax:1625), (ymin:810, ymax:955)
2025-09-13 16:46:29,506 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 345 order: 1:
2025-09-13 16:46:29,506 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:965, xmax:987), (ymin:197, ymax:341)
2025-09-13 16:46:29,682 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 721 order: 1:
2025-09-13 16:46:29,683 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:239, xmax:249), (ymin:749, ymax:890)
2025-09-13 16:46:29,860 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 387 order: 1:
2025-09-13 16:46:29,861 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1499, xmax:1523), (ymin:250, ymax:391)
2025-09-13 16:46:30,038 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 505 order: 1:
2025-09-13 16:46:30,038 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1554, xmax:1576), (ymin:437, ymax:581)
2025-09-13 16:46:30,216 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 566 order: 1:
2025-09-13 16:46:30,217 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1229, xmax:1253), (ymin:523, ymax:681)
2025-09-13 16:46:30,392 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 772 order: 1:
2025-09-13 16:46:30,393 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1731, xmax:1756), (ymin:840, ymax:987)
2025-09-13 16:46:30,569 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 722 order: 1:
2025-09-13 16:46:30,570 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:506, xmax:537), (ymin:752, ymax:902)
2025-09-13 16:46:30,747 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 872 order: 1:
2025-09-13 16:46:30,747 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1542, xmax:1552), (ymin:979, ymax:1121)
2025-09-13 16:46:30,924 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 933 order: 1:
2025-09-13 16:46:30,924 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:143, xmax:180), (ymin:1063, ymax:1212)
2025-09-13 16:46:31,103 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 1128 order: 1:
2025-09-13 16:46:31,104 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1807, xmax:1817), (ymin:1351, ymax:1489)
2025-09-13 16:46:31,277 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 1282 order: 1:
2025-09-13 16:46:31,277 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:915, xmax:948), (ymin:1569, ymax:1727)
2025-09-13 16:46:31,449 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 274 order: 1:
2025-09-13 16:46:31,450 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:505, xmax:536), (ymin:99, ymax:254)
2025-09-13 16:46:31,625 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 124 order: 1:
2025-09-13 16:46:31,626 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1182, xmax:1201), (ymin:0, ymax:16)
2025-09-13 16:46:31,802 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 641 order: 1:
2025-09-13 16:46:31,803 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:1638, xmax:1667), (ymin:619, ymax:764)
2025-09-13 16:46:31,977 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 543 order: 1:
2025-09-13 16:46:31,978 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:246, xmax:278), (ymin:476, ymax:628)
2025-09-13 16:46:32,155 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 610 order: 1:
2025-09-13 16:46:32,156 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:0, xmax:4), (ymin:568, ymax:733)
2025-09-13 16:46:32,330 - jwst.extract_2d.grisms - INFO - Subarray extracted for obj: 1188 order: 1:
2025-09-13 16:46:32,331 - jwst.extract_2d.grisms - INFO - Subarray extents are: (xmin:557, xmax:575), (ymin:1419, ymax:1580)
2025-09-13 16:46:35,608 - jwst.extract_2d.grisms - INFO - Finished extractions
2025-09-13 16:46:35,642 - stpipe.Spec2Pipeline.extract_2d - INFO - Step extract_2d done
2025-09-13 16:46:36,255 - stpipe.Spec2Pipeline.srctype - INFO - Step srctype running with args (<MultiSlitModel from jw02079004003_03101_00002_nis_rate.fits>,).
2025-09-13 16:46:36,262 - jwst.srctype.srctype - INFO - Input EXP_TYPE is NIS_WFSS
2025-09-13 16:46:36,263 - jwst.srctype.srctype - INFO - source_id=8, type=POINT
2025-09-13 16:46:36,263 - jwst.srctype.srctype - INFO - source_id=522, type=EXTENDED
2025-09-13 16:46:36,264 - jwst.srctype.srctype - INFO - source_id=796, type=EXTENDED
2025-09-13 16:46:36,265 - jwst.srctype.srctype - INFO - source_id=1479, type=EXTENDED
2025-09-13 16:46:36,265 - jwst.srctype.srctype - INFO - source_id=214, type=EXTENDED
2025-09-13 16:46:36,266 - jwst.srctype.srctype - INFO - source_id=693, type=EXTENDED
2025-09-13 16:46:36,267 - jwst.srctype.srctype - INFO - source_id=1120, type=EXTENDED
2025-09-13 16:46:36,267 - jwst.srctype.srctype - INFO - source_id=1257, type=EXTENDED
2025-09-13 16:46:36,268 - jwst.srctype.srctype - INFO - source_id=766, type=EXTENDED
2025-09-13 16:46:36,268 - jwst.srctype.srctype - INFO - source_id=606, type=POINT
2025-09-13 16:46:36,269 - jwst.srctype.srctype - INFO - source_id=649, type=EXTENDED
2025-09-13 16:46:36,269 - jwst.srctype.srctype - INFO - source_id=982, type=EXTENDED
2025-09-13 16:46:36,270 - jwst.srctype.srctype - INFO - source_id=1364, type=EXTENDED
2025-09-13 16:46:36,271 - jwst.srctype.srctype - INFO - source_id=898, type=POINT
2025-09-13 16:46:36,271 - jwst.srctype.srctype - INFO - source_id=1049, type=EXTENDED
2025-09-13 16:46:36,272 - jwst.srctype.srctype - INFO - source_id=732, type=EXTENDED
2025-09-13 16:46:36,272 - jwst.srctype.srctype - INFO - source_id=189, type=EXTENDED
2025-09-13 16:46:36,273 - jwst.srctype.srctype - INFO - source_id=881, type=POINT
2025-09-13 16:46:36,273 - jwst.srctype.srctype - INFO - source_id=966, type=EXTENDED
2025-09-13 16:46:36,274 - jwst.srctype.srctype - INFO - source_id=914, type=EXTENDED
2025-09-13 16:46:36,275 - jwst.srctype.srctype - INFO - source_id=1084, type=POINT
2025-09-13 16:46:36,275 - jwst.srctype.srctype - INFO - source_id=540, type=EXTENDED
2025-09-13 16:46:36,276 - jwst.srctype.srctype - INFO - source_id=1476, type=EXTENDED
2025-09-13 16:46:36,277 - jwst.srctype.srctype - INFO - source_id=1142, type=EXTENDED
2025-09-13 16:46:36,277 - jwst.srctype.srctype - INFO - source_id=220, type=POINT
2025-09-13 16:46:36,278 - jwst.srctype.srctype - INFO - source_id=289, type=EXTENDED
2025-09-13 16:46:36,278 - jwst.srctype.srctype - INFO - source_id=934, type=EXTENDED
2025-09-13 16:46:36,279 - jwst.srctype.srctype - INFO - source_id=1219, type=EXTENDED
2025-09-13 16:46:36,279 - jwst.srctype.srctype - INFO - source_id=927, type=EXTENDED
2025-09-13 16:46:36,280 - jwst.srctype.srctype - INFO - source_id=1417, type=EXTENDED
2025-09-13 16:46:36,281 - jwst.srctype.srctype - INFO - source_id=567, type=EXTENDED
2025-09-13 16:46:36,281 - jwst.srctype.srctype - INFO - source_id=1296, type=EXTENDED
2025-09-13 16:46:36,282 - jwst.srctype.srctype - INFO - source_id=1412, type=EXTENDED
2025-09-13 16:46:36,283 - jwst.srctype.srctype - INFO - source_id=654, type=EXTENDED
2025-09-13 16:46:36,283 - jwst.srctype.srctype - INFO - source_id=1029, type=EXTENDED
2025-09-13 16:46:36,284 - jwst.srctype.srctype - INFO - source_id=553, type=EXTENDED
2025-09-13 16:46:36,284 - jwst.srctype.srctype - INFO - source_id=1387, type=EXTENDED
2025-09-13 16:46:36,285 - jwst.srctype.srctype - INFO - source_id=422, type=EXTENDED
2025-09-13 16:46:36,286 - jwst.srctype.srctype - INFO - source_id=821, type=EXTENDED
2025-09-13 16:46:36,286 - jwst.srctype.srctype - INFO - source_id=682, type=EXTENDED
2025-09-13 16:46:36,287 - jwst.srctype.srctype - INFO - source_id=1140, type=EXTENDED
2025-09-13 16:46:36,287 - jwst.srctype.srctype - INFO - source_id=1388, type=EXTENDED
2025-09-13 16:46:36,288 - jwst.srctype.srctype - INFO - source_id=759, type=EXTENDED
2025-09-13 16:46:36,289 - jwst.srctype.srctype - INFO - source_id=1407, type=EXTENDED
2025-09-13 16:46:36,290 - jwst.srctype.srctype - INFO - source_id=1194, type=EXTENDED
2025-09-13 16:46:36,290 - jwst.srctype.srctype - INFO - source_id=712, type=EXTENDED
2025-09-13 16:46:36,291 - jwst.srctype.srctype - INFO - source_id=539, type=EXTENDED
2025-09-13 16:46:36,291 - jwst.srctype.srctype - INFO - source_id=1008, type=EXTENDED
2025-09-13 16:46:36,292 - jwst.srctype.srctype - INFO - source_id=347, type=POINT
2025-09-13 16:46:36,292 - jwst.srctype.srctype - INFO - source_id=276, type=EXTENDED
2025-09-13 16:46:36,293 - jwst.srctype.srctype - INFO - source_id=605, type=POINT
2025-09-13 16:46:36,294 - jwst.srctype.srctype - INFO - source_id=922, type=EXTENDED
2025-09-13 16:46:36,295 - jwst.srctype.srctype - INFO - source_id=736, type=EXTENDED
2025-09-13 16:46:36,295 - jwst.srctype.srctype - INFO - source_id=1423, type=EXTENDED
2025-09-13 16:46:36,296 - jwst.srctype.srctype - INFO - source_id=800, type=EXTENDED
2025-09-13 16:46:36,296 - jwst.srctype.srctype - INFO - source_id=873, type=EXTENDED
2025-09-13 16:46:36,297 - jwst.srctype.srctype - INFO - source_id=385, type=EXTENDED
2025-09-13 16:46:36,298 - jwst.srctype.srctype - INFO - source_id=557, type=EXTENDED
2025-09-13 16:46:36,298 - jwst.srctype.srctype - INFO - source_id=719, type=EXTENDED
2025-09-13 16:46:36,299 - jwst.srctype.srctype - INFO - source_id=389, type=EXTENDED
2025-09-13 16:46:36,299 - jwst.srctype.srctype - INFO - source_id=733, type=EXTENDED
2025-09-13 16:46:36,300 - jwst.srctype.srctype - INFO - source_id=1442, type=EXTENDED
2025-09-13 16:46:36,301 - jwst.srctype.srctype - INFO - source_id=417, type=EXTENDED
2025-09-13 16:46:36,302 - jwst.srctype.srctype - INFO - source_id=630, type=POINT
2025-09-13 16:46:36,302 - jwst.srctype.srctype - INFO - source_id=925, type=EXTENDED
2025-09-13 16:46:36,303 - jwst.srctype.srctype - INFO - source_id=527, type=EXTENDED
2025-09-13 16:46:36,303 - jwst.srctype.srctype - INFO - source_id=439, type=POINT
2025-09-13 16:46:36,304 - jwst.srctype.srctype - INFO - source_id=1253, type=EXTENDED
2025-09-13 16:46:36,304 - jwst.srctype.srctype - INFO - source_id=1162, type=EXTENDED
2025-09-13 16:46:36,305 - jwst.srctype.srctype - INFO - source_id=1457, type=EXTENDED
2025-09-13 16:46:36,306 - jwst.srctype.srctype - INFO - source_id=694, type=EXTENDED
2025-09-13 16:46:36,306 - jwst.srctype.srctype - INFO - source_id=1266, type=EXTENDED
2025-09-13 16:46:36,307 - jwst.srctype.srctype - INFO - source_id=298, type=EXTENDED
2025-09-13 16:46:36,308 - jwst.srctype.srctype - INFO - source_id=516, type=EXTENDED
2025-09-13 16:46:36,308 - jwst.srctype.srctype - INFO - source_id=973, type=EXTENDED
2025-09-13 16:46:36,309 - jwst.srctype.srctype - INFO - source_id=180, type=EXTENDED
2025-09-13 16:46:36,309 - jwst.srctype.srctype - INFO - source_id=980, type=EXTENDED
2025-09-13 16:46:36,310 - jwst.srctype.srctype - INFO - source_id=263, type=EXTENDED
2025-09-13 16:46:36,311 - jwst.srctype.srctype - INFO - source_id=493, type=EXTENDED
2025-09-13 16:46:36,311 - jwst.srctype.srctype - INFO - source_id=981, type=EXTENDED
2025-09-13 16:46:36,312 - jwst.srctype.srctype - INFO - source_id=1371, type=EXTENDED
2025-09-13 16:46:36,312 - jwst.srctype.srctype - INFO - source_id=536, type=EXTENDED
2025-09-13 16:46:36,313 - jwst.srctype.srctype - INFO - source_id=749, type=EXTENDED
2025-09-13 16:46:36,313 - jwst.srctype.srctype - INFO - source_id=345, type=EXTENDED
2025-09-13 16:46:36,314 - jwst.srctype.srctype - INFO - source_id=721, type=POINT
2025-09-13 16:46:36,315 - jwst.srctype.srctype - INFO - source_id=387, type=EXTENDED
2025-09-13 16:46:36,315 - jwst.srctype.srctype - INFO - source_id=505, type=EXTENDED
2025-09-13 16:46:36,316 - jwst.srctype.srctype - INFO - source_id=566, type=EXTENDED
2025-09-13 16:46:36,316 - jwst.srctype.srctype - INFO - source_id=772, type=EXTENDED
2025-09-13 16:46:36,317 - jwst.srctype.srctype - INFO - source_id=722, type=EXTENDED
2025-09-13 16:46:36,318 - jwst.srctype.srctype - INFO - source_id=872, type=POINT
2025-09-13 16:46:36,319 - jwst.srctype.srctype - INFO - source_id=933, type=EXTENDED
2025-09-13 16:46:36,319 - jwst.srctype.srctype - INFO - source_id=1128, type=POINT
2025-09-13 16:46:36,320 - jwst.srctype.srctype - INFO - source_id=1282, type=EXTENDED
2025-09-13 16:46:36,321 - jwst.srctype.srctype - INFO - source_id=274, type=EXTENDED
2025-09-13 16:46:36,321 - jwst.srctype.srctype - INFO - source_id=124, type=EXTENDED
2025-09-13 16:46:36,322 - jwst.srctype.srctype - INFO - source_id=641, type=EXTENDED
2025-09-13 16:46:36,322 - jwst.srctype.srctype - INFO - source_id=543, type=EXTENDED
2025-09-13 16:46:36,323 - jwst.srctype.srctype - INFO - source_id=610, type=POINT
2025-09-13 16:46:36,323 - jwst.srctype.srctype - INFO - source_id=1188, type=EXTENDED
2025-09-13 16:46:36,325 - stpipe.Spec2Pipeline.srctype - INFO - Step srctype done
2025-09-13 16:46:36,938 - stpipe.Spec2Pipeline.straylight - INFO - Step straylight running with args (<MultiSlitModel from jw02079004003_03101_00002_nis_rate.fits>,).
2025-09-13 16:46:36,939 - stpipe.Spec2Pipeline.straylight - INFO - Step skipped.
2025-09-13 16:46:37,535 - stpipe.Spec2Pipeline.fringe - INFO - Step fringe running with args (<MultiSlitModel from jw02079004003_03101_00002_nis_rate.fits>,).
2025-09-13 16:46:37,535 - stpipe.Spec2Pipeline.fringe - INFO - Step skipped.
2025-09-13 16:46:38,107 - stpipe.Spec2Pipeline.pathloss - INFO - Step pathloss running with args (<MultiSlitModel from jw02079004003_03101_00002_nis_rate.fits>,).
2025-09-13 16:46:38,107 - stpipe.Spec2Pipeline.pathloss - INFO - Step skipped.
2025-09-13 16:46:38,660 - stpipe.Spec2Pipeline.barshadow - INFO - Step barshadow running with args (<MultiSlitModel from jw02079004003_03101_00002_nis_rate.fits>,).
2025-09-13 16:46:38,661 - stpipe.Spec2Pipeline.barshadow - INFO - Step skipped.
2025-09-13 16:46:39,230 - stpipe.Spec2Pipeline.wfss_contam - INFO - Step wfss_contam running with args (<MultiSlitModel from jw02079004003_03101_00002_nis_rate.fits>,).
2025-09-13 16:46:39,231 - stpipe.Spec2Pipeline.wfss_contam - INFO - Step skipped.
2025-09-13 16:46:39,806 - stpipe.Spec2Pipeline.photom - INFO - Step photom running with args (<MultiSlitModel from jw02079004003_03101_00002_nis_rate.fits>,).
2025-09-13 16:46:39,852 - stpipe.Spec2Pipeline.photom - INFO - Using photom reference file: /home/runner/crds/references/jwst/niriss/jwst_niriss_photom_0041.fits
2025-09-13 16:46:39,853 - stpipe.Spec2Pipeline.photom - INFO - Using area reference file: N/A
2025-09-13 16:46:43,014 - jwst.photom.photom - INFO - Using instrument: NIRISS
2025-09-13 16:46:43,015 - jwst.photom.photom - INFO - detector: NIS
2025-09-13 16:46:43,016 - jwst.photom.photom - INFO - exp_type: NIS_WFSS
2025-09-13 16:46:43,016 - jwst.photom.photom - INFO - filter: GR150R
2025-09-13 16:46:43,017 - jwst.photom.photom - INFO - pupil: F200W
2025-09-13 16:46:43,037 - jwst.photom.photom - INFO - Attempting to obtain PIXAR_SR and PIXAR_A2 values from PHOTOM reference file.
2025-09-13 16:46:43,037 - jwst.photom.photom - INFO - Values for PIXAR_SR and PIXAR_A2 obtained from PHOTOM reference file.
2025-09-13 16:46:43,072 - jwst.photom.photom - INFO - Working on slit 8, order 1
2025-09-13 16:46:43,073 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:46:43,076 - jwst.photom.photom - INFO - Working on slit 522, order 1
2025-09-13 16:46:43,077 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:46:43,083 - jwst.photom.photom - INFO - Working on slit 796, order 1
2025-09-13 16:46:43,083 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:46:43,088 - jwst.photom.photom - INFO - Working on slit 1479, order 1
2025-09-13 16:46:43,088 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:46:43,093 - jwst.photom.photom - INFO - Working on slit 214, order 1
2025-09-13 16:46:43,094 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:46:43,098 - jwst.photom.photom - INFO - Working on slit 693, order 1
2025-09-13 16:46:43,098 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:46:43,103 - jwst.photom.photom - INFO - Working on slit 1120, order 1
2025-09-13 16:46:43,103 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:46:43,107 - jwst.photom.photom - INFO - Working on slit 1257, order 1
2025-09-13 16:46:43,108 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:46:43,113 - jwst.photom.photom - INFO - Working on slit 766, order 1
2025-09-13 16:46:43,113 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:46:43,117 - jwst.photom.photom - INFO - Working on slit 606, order 1
2025-09-13 16:46:43,118 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:46:43,122 - jwst.photom.photom - INFO - Working on slit 649, order 1
2025-09-13 16:46:43,122 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:46:43,126 - jwst.photom.photom - INFO - Working on slit 982, order 1
2025-09-13 16:46:43,127 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:46:43,131 - jwst.photom.photom - INFO - Working on slit 1364, order 1
2025-09-13 16:46:43,131 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:46:43,135 - jwst.photom.photom - INFO - Working on slit 898, order 1
2025-09-13 16:46:43,136 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:46:43,140 - jwst.photom.photom - INFO - Working on slit 1049, order 1
2025-09-13 16:46:43,140 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:46:43,144 - jwst.photom.photom - INFO - Working on slit 732, order 1
2025-09-13 16:46:43,145 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:46:43,148 - jwst.photom.photom - INFO - Working on slit 189, order 1
2025-09-13 16:46:43,149 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:46:43,153 - jwst.photom.photom - INFO - Working on slit 881, order 1
2025-09-13 16:46:43,154 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:46:43,157 - jwst.photom.photom - INFO - Working on slit 966, order 1
2025-09-13 16:46:43,158 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:46:43,162 - jwst.photom.photom - INFO - Working on slit 914, order 1
2025-09-13 16:46:43,163 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:46:43,166 - jwst.photom.photom - INFO - Working on slit 1084, order 1
2025-09-13 16:46:43,167 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:46:43,171 - jwst.photom.photom - INFO - Working on slit 540, order 1
2025-09-13 16:46:43,172 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:46:43,175 - jwst.photom.photom - INFO - Working on slit 1476, order 1
2025-09-13 16:46:43,176 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:46:43,180 - jwst.photom.photom - INFO - Working on slit 1142, order 1
2025-09-13 16:46:43,181 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:46:43,184 - jwst.photom.photom - INFO - Working on slit 220, order 1
2025-09-13 16:46:43,185 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:46:43,189 - jwst.photom.photom - INFO - Working on slit 289, order 1
2025-09-13 16:46:43,189 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:46:43,193 - jwst.photom.photom - INFO - Working on slit 934, order 1
2025-09-13 16:46:43,194 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:46:43,197 - jwst.photom.photom - INFO - Working on slit 1219, order 1
2025-09-13 16:46:43,198 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:46:43,202 - jwst.photom.photom - INFO - Working on slit 927, order 1
2025-09-13 16:46:43,203 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:46:43,207 - jwst.photom.photom - INFO - Working on slit 1417, order 1
2025-09-13 16:46:43,207 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:46:43,211 - jwst.photom.photom - INFO - Working on slit 567, order 1
2025-09-13 16:46:43,212 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:46:43,216 - jwst.photom.photom - INFO - Working on slit 1296, order 1
2025-09-13 16:46:43,217 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:46:43,221 - jwst.photom.photom - INFO - Working on slit 1412, order 1
2025-09-13 16:46:43,221 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:46:43,225 - jwst.photom.photom - INFO - Working on slit 654, order 1
2025-09-13 16:46:43,226 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:46:43,230 - jwst.photom.photom - INFO - Working on slit 1029, order 1
2025-09-13 16:46:43,231 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:46:43,234 - jwst.photom.photom - INFO - Working on slit 553, order 1
2025-09-13 16:46:43,235 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:46:43,239 - jwst.photom.photom - INFO - Working on slit 1387, order 1
2025-09-13 16:46:43,240 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:46:43,243 - jwst.photom.photom - INFO - Working on slit 422, order 1
2025-09-13 16:46:43,244 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:46:43,248 - jwst.photom.photom - INFO - Working on slit 821, order 1
2025-09-13 16:46:43,249 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:46:43,252 - jwst.photom.photom - INFO - Working on slit 682, order 1
2025-09-13 16:46:43,253 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:46:43,257 - jwst.photom.photom - INFO - Working on slit 1140, order 1
2025-09-13 16:46:43,257 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:46:43,261 - jwst.photom.photom - INFO - Working on slit 1388, order 1
2025-09-13 16:46:43,262 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:46:43,266 - jwst.photom.photom - INFO - Working on slit 759, order 1
2025-09-13 16:46:43,267 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:46:43,270 - jwst.photom.photom - INFO - Working on slit 1407, order 1
2025-09-13 16:46:43,271 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:46:43,274 - jwst.photom.photom - INFO - Working on slit 1194, order 1
2025-09-13 16:46:43,275 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:46:43,279 - jwst.photom.photom - INFO - Working on slit 712, order 1
2025-09-13 16:46:43,280 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:46:43,283 - jwst.photom.photom - INFO - Working on slit 539, order 1
2025-09-13 16:46:43,284 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:46:43,287 - jwst.photom.photom - INFO - Working on slit 1008, order 1
2025-09-13 16:46:43,288 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:46:43,291 - jwst.photom.photom - INFO - Working on slit 347, order 1
2025-09-13 16:46:43,292 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:46:43,296 - jwst.photom.photom - INFO - Working on slit 276, order 1
2025-09-13 16:46:43,296 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:46:43,300 - jwst.photom.photom - INFO - Working on slit 605, order 1
2025-09-13 16:46:43,301 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:46:43,304 - jwst.photom.photom - INFO - Working on slit 922, order 1
2025-09-13 16:46:43,305 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:46:43,308 - jwst.photom.photom - INFO - Working on slit 736, order 1
2025-09-13 16:46:43,309 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:46:43,312 - jwst.photom.photom - INFO - Working on slit 1423, order 1
2025-09-13 16:46:43,313 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:46:43,316 - jwst.photom.photom - INFO - Working on slit 800, order 1
2025-09-13 16:46:43,317 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:46:43,320 - jwst.photom.photom - INFO - Working on slit 873, order 1
2025-09-13 16:46:43,321 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:46:43,325 - jwst.photom.photom - INFO - Working on slit 385, order 1
2025-09-13 16:46:43,325 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:46:43,329 - jwst.photom.photom - INFO - Working on slit 557, order 1
2025-09-13 16:46:43,330 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:46:43,333 - jwst.photom.photom - INFO - Working on slit 719, order 1
2025-09-13 16:46:43,334 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:46:43,337 - jwst.photom.photom - INFO - Working on slit 389, order 1
2025-09-13 16:46:43,338 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:46:43,342 - jwst.photom.photom - INFO - Working on slit 733, order 1
2025-09-13 16:46:43,342 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:46:43,346 - jwst.photom.photom - INFO - Working on slit 1442, order 1
2025-09-13 16:46:43,347 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:46:43,351 - jwst.photom.photom - INFO - Working on slit 417, order 1
2025-09-13 16:46:43,351 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:46:43,355 - jwst.photom.photom - INFO - Working on slit 630, order 1
2025-09-13 16:46:43,355 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:46:43,359 - jwst.photom.photom - INFO - Working on slit 925, order 1
2025-09-13 16:46:43,360 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:46:43,363 - jwst.photom.photom - INFO - Working on slit 527, order 1
2025-09-13 16:46:43,364 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:46:43,367 - jwst.photom.photom - INFO - Working on slit 439, order 1
2025-09-13 16:46:43,368 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:46:43,371 - jwst.photom.photom - INFO - Working on slit 1253, order 1
2025-09-13 16:46:43,372 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:46:43,376 - jwst.photom.photom - INFO - Working on slit 1162, order 1
2025-09-13 16:46:43,376 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:46:43,380 - jwst.photom.photom - INFO - Working on slit 1457, order 1
2025-09-13 16:46:43,381 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:46:43,384 - jwst.photom.photom - INFO - Working on slit 694, order 1
2025-09-13 16:46:43,385 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:46:43,388 - jwst.photom.photom - INFO - Working on slit 1266, order 1
2025-09-13 16:46:43,389 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:46:43,392 - jwst.photom.photom - INFO - Working on slit 298, order 1
2025-09-13 16:46:43,393 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:46:43,397 - jwst.photom.photom - INFO - Working on slit 516, order 1
2025-09-13 16:46:43,397 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:46:43,401 - jwst.photom.photom - INFO - Working on slit 973, order 1
2025-09-13 16:46:43,402 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:46:43,405 - jwst.photom.photom - INFO - Working on slit 180, order 1
2025-09-13 16:46:43,406 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:46:43,409 - jwst.photom.photom - INFO - Working on slit 980, order 1
2025-09-13 16:46:43,410 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:46:43,414 - jwst.photom.photom - INFO - Working on slit 263, order 1
2025-09-13 16:46:43,414 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:46:43,418 - jwst.photom.photom - INFO - Working on slit 493, order 1
2025-09-13 16:46:43,418 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:46:43,422 - jwst.photom.photom - INFO - Working on slit 981, order 1
2025-09-13 16:46:43,422 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:46:43,426 - jwst.photom.photom - INFO - Working on slit 1371, order 1
2025-09-13 16:46:43,427 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:46:43,430 - jwst.photom.photom - INFO - Working on slit 536, order 1
2025-09-13 16:46:43,431 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:46:43,435 - jwst.photom.photom - INFO - Working on slit 749, order 1
2025-09-13 16:46:43,435 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:46:43,439 - jwst.photom.photom - INFO - Working on slit 345, order 1
2025-09-13 16:46:43,440 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:46:43,443 - jwst.photom.photom - INFO - Working on slit 721, order 1
2025-09-13 16:46:43,444 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:46:43,447 - jwst.photom.photom - INFO - Working on slit 387, order 1
2025-09-13 16:46:43,448 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:46:43,451 - jwst.photom.photom - INFO - Working on slit 505, order 1
2025-09-13 16:46:43,452 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:46:43,455 - jwst.photom.photom - INFO - Working on slit 566, order 1
2025-09-13 16:46:43,456 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:46:43,460 - jwst.photom.photom - INFO - Working on slit 772, order 1
2025-09-13 16:46:43,460 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:46:43,464 - jwst.photom.photom - INFO - Working on slit 722, order 1
2025-09-13 16:46:43,464 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:46:43,468 - jwst.photom.photom - INFO - Working on slit 872, order 1
2025-09-13 16:46:43,469 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:46:43,472 - jwst.photom.photom - INFO - Working on slit 933, order 1
2025-09-13 16:46:43,473 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:46:43,476 - jwst.photom.photom - INFO - Working on slit 1128, order 1
2025-09-13 16:46:43,477 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:46:43,480 - jwst.photom.photom - INFO - Working on slit 1282, order 1
2025-09-13 16:46:43,481 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:46:43,484 - jwst.photom.photom - INFO - Working on slit 274, order 1
2025-09-13 16:46:43,485 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:46:43,489 - jwst.photom.photom - INFO - Working on slit 124, order 1
2025-09-13 16:46:43,489 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:46:43,492 - jwst.photom.photom - INFO - Working on slit 641, order 1
2025-09-13 16:46:43,493 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:46:43,497 - jwst.photom.photom - INFO - Working on slit 543, order 1
2025-09-13 16:46:43,498 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:46:43,501 - jwst.photom.photom - INFO - Working on slit 610, order 1
2025-09-13 16:46:43,502 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:46:43,505 - jwst.photom.photom - INFO - Working on slit 1188, order 1
2025-09-13 16:46:43,506 - jwst.photom.photom - INFO - PHOTMJSR value: 49.086
2025-09-13 16:46:43,514 - stpipe.Spec2Pipeline.photom - INFO - Step photom done
2025-09-13 16:46:46,549 - stpipe.Spec2Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<MultiSlitModel from /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage2_spec/jw02079004003_03101_00002_nis_cal.fits>,).
2025-09-13 16:46:46,550 - stpipe.Spec2Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 16:46:49,529 - stpipe.Spec2Pipeline.extract_1d - INFO - Step extract_1d running with args (<MultiSlitModel from /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage2_spec/jw02079004003_03101_00002_nis_cal.fits>,).
2025-09-13 16:46:49,652 - stpipe.Spec2Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 16:46:49,702 - jwst.extract_1d.extract - INFO - Working on slit 8
2025-09-13 16:46:49,703 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type POINT
2025-09-13 16:46:49,703 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 10.00 (inclusive)
2025-09-13 16:46:49,710 - jwst.extract_1d.extract - INFO - Creating aperture correction.
2025-09-13 16:46:49,776 - jwst.extract_1d.extract - INFO - Working on slit 522
2025-09-13 16:46:49,777 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:46:49,779 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 146.00 (inclusive)
2025-09-13 16:46:49,833 - jwst.extract_1d.extract - INFO - Working on slit 796
2025-09-13 16:46:49,835 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:46:49,836 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 93.00 (inclusive)
2025-09-13 16:46:49,889 - jwst.extract_1d.extract - INFO - Working on slit 1479
2025-09-13 16:46:49,890 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:46:49,891 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 102.00 (inclusive)
2025-09-13 16:46:49,945 - jwst.extract_1d.extract - INFO - Working on slit 214
2025-09-13 16:46:49,946 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:46:49,947 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 84.00 (inclusive)
2025-09-13 16:46:50,001 - jwst.extract_1d.extract - INFO - Working on slit 693
2025-09-13 16:46:50,002 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:46:50,003 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 71.00 (inclusive)
2025-09-13 16:46:50,057 - jwst.extract_1d.extract - INFO - Working on slit 1120
2025-09-13 16:46:50,058 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:46:50,059 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 109.00 (inclusive)
2025-09-13 16:46:50,114 - jwst.extract_1d.extract - INFO - Working on slit 1257
2025-09-13 16:46:50,115 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:46:50,116 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 103.00 (inclusive)
2025-09-13 16:46:50,170 - jwst.extract_1d.extract - INFO - Working on slit 766
2025-09-13 16:46:50,171 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:46:50,172 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 52.00 (inclusive)
2025-09-13 16:46:50,225 - jwst.extract_1d.extract - INFO - Working on slit 606
2025-09-13 16:46:50,226 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type POINT
2025-09-13 16:46:50,227 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 10.00 (inclusive)
2025-09-13 16:46:50,234 - jwst.extract_1d.extract - INFO - Creating aperture correction.
2025-09-13 16:46:50,370 - jwst.extract_1d.extract - INFO - Working on slit 649
2025-09-13 16:46:50,371 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:46:50,372 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 90.00 (inclusive)
2025-09-13 16:46:50,426 - jwst.extract_1d.extract - INFO - Working on slit 982
2025-09-13 16:46:50,427 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:46:50,428 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 48.00 (inclusive)
2025-09-13 16:46:50,482 - jwst.extract_1d.extract - INFO - Working on slit 1364
2025-09-13 16:46:50,483 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:46:50,484 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 43.00 (inclusive)
2025-09-13 16:46:50,537 - jwst.extract_1d.extract - INFO - Working on slit 898
2025-09-13 16:46:50,538 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type POINT
2025-09-13 16:46:50,539 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 10.00 (inclusive)
2025-09-13 16:46:50,546 - jwst.extract_1d.extract - INFO - Creating aperture correction.
2025-09-13 16:46:50,696 - jwst.extract_1d.extract - INFO - Working on slit 1049
2025-09-13 16:46:50,698 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:46:50,698 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 24.00 (inclusive)
2025-09-13 16:46:50,753 - jwst.extract_1d.extract - INFO - Working on slit 732
2025-09-13 16:46:50,754 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:46:50,755 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 65.00 (inclusive)
2025-09-13 16:46:50,811 - jwst.extract_1d.extract - INFO - Working on slit 189
2025-09-13 16:46:50,812 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:46:50,813 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 47.00 (inclusive)
2025-09-13 16:46:50,866 - jwst.extract_1d.extract - INFO - Working on slit 881
2025-09-13 16:46:50,868 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type POINT
2025-09-13 16:46:50,868 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 10.00 (inclusive)
2025-09-13 16:46:50,875 - jwst.extract_1d.extract - INFO - Creating aperture correction.
2025-09-13 16:46:51,014 - jwst.extract_1d.extract - INFO - Working on slit 966
2025-09-13 16:46:51,015 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:46:51,016 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 54.00 (inclusive)
2025-09-13 16:46:51,071 - jwst.extract_1d.extract - INFO - Working on slit 914
2025-09-13 16:46:51,072 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:46:51,073 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 43.00 (inclusive)
2025-09-13 16:46:51,126 - jwst.extract_1d.extract - INFO - Working on slit 1084
2025-09-13 16:46:51,127 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type POINT
2025-09-13 16:46:51,128 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 10.00 (inclusive)
2025-09-13 16:46:51,134 - jwst.extract_1d.extract - INFO - Creating aperture correction.
2025-09-13 16:46:51,261 - jwst.extract_1d.extract - INFO - Working on slit 540
2025-09-13 16:46:51,262 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:46:51,263 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 62.00 (inclusive)
2025-09-13 16:46:51,317 - jwst.extract_1d.extract - INFO - Working on slit 1476
2025-09-13 16:46:51,318 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:46:51,319 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 49.00 (inclusive)
2025-09-13 16:46:51,372 - jwst.extract_1d.extract - INFO - Working on slit 1142
2025-09-13 16:46:51,373 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:46:51,373 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 44.00 (inclusive)
2025-09-13 16:46:51,426 - jwst.extract_1d.extract - INFO - Working on slit 220
2025-09-13 16:46:51,427 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type POINT
2025-09-13 16:46:51,428 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 10.00 (inclusive)
2025-09-13 16:46:51,434 - jwst.extract_1d.extract - INFO - Creating aperture correction.
2025-09-13 16:46:51,565 - jwst.extract_1d.extract - INFO - Working on slit 289
2025-09-13 16:46:51,566 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:46:51,567 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 48.00 (inclusive)
2025-09-13 16:46:51,620 - jwst.extract_1d.extract - INFO - Working on slit 934
2025-09-13 16:46:51,621 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:46:51,622 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 49.00 (inclusive)
2025-09-13 16:46:51,675 - jwst.extract_1d.extract - INFO - Working on slit 1219
2025-09-13 16:46:51,676 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:46:51,677 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 44.00 (inclusive)
2025-09-13 16:46:51,732 - jwst.extract_1d.extract - INFO - Working on slit 927
2025-09-13 16:46:51,733 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:46:51,733 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 51.00 (inclusive)
2025-09-13 16:46:51,786 - jwst.extract_1d.extract - INFO - Working on slit 1417
2025-09-13 16:46:51,787 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:46:51,788 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 39.00 (inclusive)
2025-09-13 16:46:51,840 - jwst.extract_1d.extract - INFO - Working on slit 567
2025-09-13 16:46:51,841 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:46:51,842 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 45.00 (inclusive)
2025-09-13 16:46:51,895 - jwst.extract_1d.extract - INFO - Working on slit 1296
2025-09-13 16:46:51,896 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:46:51,897 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 42.00 (inclusive)
2025-09-13 16:46:51,950 - jwst.extract_1d.extract - INFO - Working on slit 1412
2025-09-13 16:46:51,951 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:46:51,952 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 39.00 (inclusive)
2025-09-13 16:46:52,004 - jwst.extract_1d.extract - INFO - Working on slit 654
2025-09-13 16:46:52,005 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:46:52,006 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 65.00 (inclusive)
2025-09-13 16:46:52,059 - jwst.extract_1d.extract - INFO - Working on slit 1029
2025-09-13 16:46:52,060 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:46:52,061 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 74.00 (inclusive)
2025-09-13 16:46:52,114 - jwst.extract_1d.extract - INFO - Working on slit 553
2025-09-13 16:46:52,115 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:46:52,115 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 47.00 (inclusive)
2025-09-13 16:46:52,167 - jwst.extract_1d.extract - INFO - Working on slit 1387
2025-09-13 16:46:52,168 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:46:52,169 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 38.00 (inclusive)
2025-09-13 16:46:52,221 - jwst.extract_1d.extract - INFO - Working on slit 422
2025-09-13 16:46:52,222 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:46:52,223 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 32.00 (inclusive)
2025-09-13 16:46:52,275 - jwst.extract_1d.extract - INFO - Working on slit 821
2025-09-13 16:46:52,276 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:46:52,277 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 37.00 (inclusive)
2025-09-13 16:46:52,330 - jwst.extract_1d.extract - INFO - Working on slit 682
2025-09-13 16:46:52,331 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:46:52,332 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 42.00 (inclusive)
2025-09-13 16:46:52,385 - jwst.extract_1d.extract - INFO - Working on slit 1140
2025-09-13 16:46:52,386 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:46:52,387 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 47.00 (inclusive)
2025-09-13 16:46:52,438 - jwst.extract_1d.extract - INFO - Working on slit 1388
2025-09-13 16:46:52,439 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:46:52,440 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 50.00 (inclusive)
2025-09-13 16:46:52,492 - jwst.extract_1d.extract - INFO - Working on slit 759
2025-09-13 16:46:52,493 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:46:52,494 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 44.00 (inclusive)
2025-09-13 16:46:52,547 - jwst.extract_1d.extract - INFO - Working on slit 1407
2025-09-13 16:46:52,548 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:46:52,549 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 41.00 (inclusive)
2025-09-13 16:46:52,600 - jwst.extract_1d.extract - INFO - Working on slit 1194
2025-09-13 16:46:52,601 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:46:52,602 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 41.00 (inclusive)
2025-09-13 16:46:52,653 - jwst.extract_1d.extract - INFO - Working on slit 712
2025-09-13 16:46:52,654 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:46:52,655 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 41.00 (inclusive)
2025-09-13 16:46:52,708 - jwst.extract_1d.extract - INFO - Working on slit 539
2025-09-13 16:46:52,709 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:46:52,710 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 28.00 (inclusive)
2025-09-13 16:46:52,763 - jwst.extract_1d.extract - INFO - Working on slit 1008
2025-09-13 16:46:52,764 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:46:52,764 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 32.00 (inclusive)
2025-09-13 16:46:52,817 - jwst.extract_1d.extract - INFO - Working on slit 347
2025-09-13 16:46:52,818 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type POINT
2025-09-13 16:46:52,819 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 10.00 (inclusive)
2025-09-13 16:46:52,826 - jwst.extract_1d.extract - INFO - Creating aperture correction.
2025-09-13 16:46:52,951 - jwst.extract_1d.extract - INFO - Working on slit 276
2025-09-13 16:46:52,953 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:46:52,953 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 43.00 (inclusive)
2025-09-13 16:46:53,005 - jwst.extract_1d.extract - INFO - Working on slit 605
2025-09-13 16:46:53,006 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type POINT
2025-09-13 16:46:53,007 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 10.00 (inclusive)
2025-09-13 16:46:53,013 - jwst.extract_1d.extract - INFO - Creating aperture correction.
2025-09-13 16:46:53,130 - jwst.extract_1d.extract - INFO - Working on slit 922
2025-09-13 16:46:53,131 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:46:53,132 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 31.00 (inclusive)
2025-09-13 16:46:53,185 - jwst.extract_1d.extract - INFO - Working on slit 736
2025-09-13 16:46:53,186 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:46:53,187 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 19.00 (inclusive)
2025-09-13 16:46:53,240 - jwst.extract_1d.extract - INFO - Working on slit 1423
2025-09-13 16:46:53,241 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:46:53,242 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 33.00 (inclusive)
2025-09-13 16:46:53,293 - jwst.extract_1d.extract - INFO - Working on slit 800
2025-09-13 16:46:53,294 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:46:53,295 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 27.00 (inclusive)
2025-09-13 16:46:53,349 - jwst.extract_1d.extract - INFO - Working on slit 873
2025-09-13 16:46:53,350 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:46:53,350 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 23.00 (inclusive)
2025-09-13 16:46:53,402 - jwst.extract_1d.extract - INFO - Working on slit 385
2025-09-13 16:46:53,403 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:46:53,404 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 41.00 (inclusive)
2025-09-13 16:46:53,456 - jwst.extract_1d.extract - INFO - Working on slit 557
2025-09-13 16:46:53,457 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:46:53,458 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 38.00 (inclusive)
2025-09-13 16:46:53,510 - jwst.extract_1d.extract - INFO - Working on slit 719
2025-09-13 16:46:53,511 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:46:53,512 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 24.00 (inclusive)
2025-09-13 16:46:53,563 - jwst.extract_1d.extract - INFO - Working on slit 389
2025-09-13 16:46:53,564 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:46:53,565 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 32.00 (inclusive)
2025-09-13 16:46:53,617 - jwst.extract_1d.extract - INFO - Working on slit 733
2025-09-13 16:46:53,618 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:46:53,618 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 53.00 (inclusive)
2025-09-13 16:46:53,670 - jwst.extract_1d.extract - INFO - Working on slit 1442
2025-09-13 16:46:53,671 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:46:53,672 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 44.00 (inclusive)
2025-09-13 16:46:53,724 - jwst.extract_1d.extract - INFO - Working on slit 417
2025-09-13 16:46:53,725 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:46:53,726 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 26.00 (inclusive)
2025-09-13 16:46:53,777 - jwst.extract_1d.extract - INFO - Working on slit 630
2025-09-13 16:46:53,778 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type POINT
2025-09-13 16:46:53,779 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 10.00 (inclusive)
2025-09-13 16:46:53,785 - jwst.extract_1d.extract - INFO - Creating aperture correction.
2025-09-13 16:46:53,898 - jwst.extract_1d.extract - INFO - Working on slit 925
2025-09-13 16:46:53,899 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:46:53,900 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 42.00 (inclusive)
2025-09-13 16:46:53,952 - jwst.extract_1d.extract - INFO - Working on slit 527
2025-09-13 16:46:53,953 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:46:53,954 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 28.00 (inclusive)
2025-09-13 16:46:54,006 - jwst.extract_1d.extract - INFO - Working on slit 439
2025-09-13 16:46:54,007 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type POINT
2025-09-13 16:46:54,008 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 10.00 (inclusive)
2025-09-13 16:46:54,014 - jwst.extract_1d.extract - INFO - Creating aperture correction.
2025-09-13 16:46:54,135 - jwst.extract_1d.extract - INFO - Working on slit 1253
2025-09-13 16:46:54,136 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:46:54,137 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 23.00 (inclusive)
2025-09-13 16:46:54,191 - jwst.extract_1d.extract - INFO - Working on slit 1162
2025-09-13 16:46:54,192 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:46:54,193 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 20.00 (inclusive)
2025-09-13 16:46:54,246 - jwst.extract_1d.extract - INFO - Working on slit 1457
2025-09-13 16:46:54,247 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:46:54,248 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 24.00 (inclusive)
2025-09-13 16:46:54,301 - jwst.extract_1d.extract - INFO - Working on slit 694
2025-09-13 16:46:54,302 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:46:54,303 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 44.00 (inclusive)
2025-09-13 16:46:54,356 - jwst.extract_1d.extract - INFO - Working on slit 1266
2025-09-13 16:46:54,357 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:46:54,358 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 36.00 (inclusive)
2025-09-13 16:46:54,410 - jwst.extract_1d.extract - INFO - Working on slit 298
2025-09-13 16:46:54,411 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:46:54,412 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 32.00 (inclusive)
2025-09-13 16:46:54,466 - jwst.extract_1d.extract - INFO - Working on slit 516
2025-09-13 16:46:54,467 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:46:54,468 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 31.00 (inclusive)
2025-09-13 16:46:54,522 - jwst.extract_1d.extract - INFO - Working on slit 973
2025-09-13 16:46:54,523 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:46:54,524 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 23.00 (inclusive)
2025-09-13 16:46:54,577 - jwst.extract_1d.extract - INFO - Working on slit 180
2025-09-13 16:46:54,578 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:46:54,578 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 43.00 (inclusive)
2025-09-13 16:46:54,631 - jwst.extract_1d.extract - INFO - Working on slit 980
2025-09-13 16:46:54,632 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:46:54,632 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 39.00 (inclusive)
2025-09-13 16:46:54,684 - jwst.extract_1d.extract - INFO - Working on slit 263
2025-09-13 16:46:54,685 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:46:54,686 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 39.00 (inclusive)
2025-09-13 16:46:54,739 - jwst.extract_1d.extract - INFO - Working on slit 493
2025-09-13 16:46:54,740 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:46:54,741 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 30.00 (inclusive)
2025-09-13 16:46:54,795 - jwst.extract_1d.extract - INFO - Working on slit 981
2025-09-13 16:46:54,796 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:46:54,797 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 19.00 (inclusive)
2025-09-13 16:46:54,850 - jwst.extract_1d.extract - INFO - Working on slit 1371
2025-09-13 16:46:54,851 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:46:54,852 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 24.00 (inclusive)
2025-09-13 16:46:54,907 - jwst.extract_1d.extract - INFO - Working on slit 536
2025-09-13 16:46:54,908 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:46:54,909 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 23.00 (inclusive)
2025-09-13 16:46:54,964 - jwst.extract_1d.extract - INFO - Working on slit 749
2025-09-13 16:46:54,965 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:46:54,966 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 26.00 (inclusive)
2025-09-13 16:46:55,018 - jwst.extract_1d.extract - INFO - Working on slit 345
2025-09-13 16:46:55,019 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:46:55,020 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 22.00 (inclusive)
2025-09-13 16:46:55,071 - jwst.extract_1d.extract - INFO - Working on slit 721
2025-09-13 16:46:55,072 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type POINT
2025-09-13 16:46:55,073 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 10.00 (inclusive)
2025-09-13 16:46:55,080 - jwst.extract_1d.extract - INFO - Creating aperture correction.
2025-09-13 16:46:55,196 - jwst.extract_1d.extract - INFO - Working on slit 387
2025-09-13 16:46:55,197 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:46:55,198 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 24.00 (inclusive)
2025-09-13 16:46:55,250 - jwst.extract_1d.extract - INFO - Working on slit 505
2025-09-13 16:46:55,251 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:46:55,252 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 22.00 (inclusive)
2025-09-13 16:46:55,304 - jwst.extract_1d.extract - INFO - Working on slit 566
2025-09-13 16:46:55,306 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:46:55,306 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 24.00 (inclusive)
2025-09-13 16:46:55,360 - jwst.extract_1d.extract - INFO - Working on slit 772
2025-09-13 16:46:55,361 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:46:55,362 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 25.00 (inclusive)
2025-09-13 16:46:55,414 - jwst.extract_1d.extract - INFO - Working on slit 722
2025-09-13 16:46:55,415 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:46:55,416 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 31.00 (inclusive)
2025-09-13 16:46:55,468 - jwst.extract_1d.extract - INFO - Working on slit 872
2025-09-13 16:46:55,469 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type POINT
2025-09-13 16:46:55,470 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 10.00 (inclusive)
2025-09-13 16:46:55,477 - jwst.extract_1d.extract - INFO - Creating aperture correction.
2025-09-13 16:46:55,594 - jwst.extract_1d.extract - INFO - Working on slit 933
2025-09-13 16:46:55,595 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:46:55,596 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 37.00 (inclusive)
2025-09-13 16:46:55,649 - jwst.extract_1d.extract - INFO - Working on slit 1128
2025-09-13 16:46:55,650 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type POINT
2025-09-13 16:46:55,651 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 10.00 (inclusive)
2025-09-13 16:46:55,658 - jwst.extract_1d.extract - INFO - Creating aperture correction.
2025-09-13 16:46:55,772 - jwst.extract_1d.extract - INFO - Working on slit 1282
2025-09-13 16:46:55,773 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:46:55,774 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 33.00 (inclusive)
2025-09-13 16:46:55,828 - jwst.extract_1d.extract - INFO - Working on slit 274
2025-09-13 16:46:55,829 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:46:55,830 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 31.00 (inclusive)
2025-09-13 16:46:55,883 - jwst.extract_1d.extract - INFO - Working on slit 124
2025-09-13 16:46:55,884 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:46:55,884 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 19.00 (inclusive)
2025-09-13 16:46:55,936 - jwst.extract_1d.extract - INFO - Working on slit 641
2025-09-13 16:46:55,937 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:46:55,938 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 29.00 (inclusive)
2025-09-13 16:46:55,990 - jwst.extract_1d.extract - INFO - Working on slit 543
2025-09-13 16:46:55,991 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:46:55,992 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 32.00 (inclusive)
2025-09-13 16:46:56,045 - jwst.extract_1d.extract - INFO - Working on slit 610
2025-09-13 16:46:56,045 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type POINT
2025-09-13 16:46:56,046 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 4.00 (inclusive)
2025-09-13 16:46:56,053 - jwst.extract_1d.extract - INFO - Creating aperture correction.
2025-09-13 16:46:56,182 - jwst.extract_1d.extract - INFO - Working on slit 1188
2025-09-13 16:46:56,183 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:46:56,183 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 18.00 (inclusive)
2025-09-13 16:46:56,503 - stpipe.Spec2Pipeline.extract_1d - INFO - Saved model in /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage2_spec/jw02079004003_03101_00002_nis_x1d.fits
2025-09-13 16:46:56,504 - stpipe.Spec2Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 16:46:56,507 - stpipe.Spec2Pipeline - INFO - Finished processing product /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage1/jw02079004003_03101_00002_nis
2025-09-13 16:46:56,510 - stpipe.Spec2Pipeline - INFO - Ending calwebb_spec2
2025-09-13 16:46:56,511 - jwst.stpipe.core - INFO - Results used CRDS context: jwst_1413.pmap
2025-09-13 16:47:08,028 - stpipe.Spec2Pipeline - INFO - Saved model in /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage2_spec/jw02079004003_03101_00002_nis_cal.fits
2025-09-13 16:47:08,029 - stpipe.Spec2Pipeline - INFO - Step Spec2Pipeline done
2025-09-13 16:47:08,029 - jwst.stpipe.core - INFO - Results used jwst version: 1.19.1
# Print out the time benchmark
time_spec2_end = time.perf_counter()
print(f"Runtime for Spec2: {(time_spec2_end - time_spec2)/60:0.0f} minutes")
Runtime for Spec2: 17 minutes
Visualize Spec2 Outputs#
In NIRISS WFSS data there are many sources of interest to look at. In this visualization we look at, for five selected sources, the source as it appears in the i2d image, two example grism *_cal.fits
2-D spectral cutouts (if available, otherwise they may appear blank), and the level 2 *_x1d.fits
1-D extracted spectra for all grism dithers where available. With the contamination step currently turned off, the contamination can be easily visible when comparing the 1-D and 2-D spectra of the two grisms.
Note that the *_cal.fits
data for GR150R are transposed so that the dispersion direction is along the -x axis. For both GR150R and GR150C *_cal.fits
files, the axis is then flipped for visualization purposes
# here we look at the source as identified by the source catalog in the i2d image, the two grism cal files, and the x1d files
# this cell is grabbing the files & sources to look at
if doviz:
# grab the spec2 x1d output products
spec2_x1d_files = sorted(glob.glob(os.path.join(spec2_dir, '*nis_x1d.fits*')))
# If there are multiple pupils (blocking filters) pick one for illustration
spec2_unique_pupils = np.unique([fits.getval(x1d, 'PUPIL') for x1d in spec2_x1d_files])
pupil_x1ds = [x1d for x1d in spec2_x1d_files if fits.getval(x1d, 'PUPIL') == spec2_unique_pupils[0]]
if demo_mode:
# find the source catalog for this set of filters
source_catfile = os.path.join(image3_dir, fits.getval(pupil_x1ds[0], 'SCATFILE'))
# define some cool sources to look at if using the demo mode data
ra_decs = [(53.149299532671414, -27.788593590014425), # galaxy strong emission
(53.1490537204553, -27.774406172992315), # galaxy with contamination
(53.14917151184476, -27.79305522163517), # galaxy with contamination
(53.17659115324354, -27.785519434446663), # larger footprint galaxy
(53.158405995297684, -27.794984326598932)] # point source
sources = [find_closest_source_id(ra, dec, source_catfile) for ra, dec in ra_decs]
nsources = len(sources)
else:
# or grab some sources from the first x1d file
nsources = 5 # 100 sources are extracted by default
source_offset = 10 # offsetting what nsources to plot to avoid extra bright sources
with fits.open(pupil_x1ds[0]) as temp_x1d:
sources = temp_x1d[1].data['SOURCE_ID'][source_offset:nsources+source_offset]
# here we look at the source as identified by the source catalog in the i2d image, the two grism cal files, and the x1d files
# this cell is doing the figure set-up and plotting
if doviz:
# setting up the figure
cols = 4
rows = nsources
fig = plt.figure(figsize=(15, 4*(rows/2)))
fig.suptitle(f"Spec2 Products for PID{program} o{sci_observtn} {spec2_unique_pupils[0]}")
# looping through the different sources to plot; one per row
for nsource, source_id in enumerate(sources):
# we are only plotting a single cal file cutout for each grism
plot_gr150r = True
plot_gr150c = True
# setting up the subplots for a single source
ypos = nsource
ax_i2d = plt.subplot2grid((rows, cols), (ypos, 0))
ax_cal_r = plt.subplot2grid((rows, cols), (ypos, 1))
ax_cal_c = plt.subplot2grid((rows, cols), (ypos, 2))
ax_x1d = plt.subplot2grid((rows, cols), (ypos, 3))
source_fluxes = [] # save the source flux to set the plot limits
# plot all of the 1-D spectra from the x1d files
for nfile, x1dfile in enumerate(pupil_x1ds):
ax_x1d, catname, source_fluxes, grism = plot_spectrum(x1dfile, source_fluxes, ax_x1d, image3_dir, legend=False)
# plot the direct image of the source based on the source number from the source catalog
if nfile == 0:
ax_i2d = plot_i2d_plus_source(catname, source_id, ax_i2d)
# plot one example cal image from the GR150R grism, transposed to disperse in the same direction as GR150C
if plot_gr150r and grism == 'GR150R':
ax_cal_r = plot_spec2_cal(x1dfile, source_id, ax_cal_r, transpose=True)
plot_gr150r = False
# plot one example cal image from the GR150C grism
if plot_gr150c and grism == 'GR150C':
ax_cal_c = plot_spec2_cal(x1dfile, source_id, ax_cal_c)
plot_gr150c = False
if len(source_fluxes):
# there may not have been data to extract if everything was saturated
ax_x1d.set_ylim(np.nanmin(source_fluxes), np.nanmax(source_fluxes))
ax_x1d.legend(bbox_to_anchor=(1, 1), ncols=np.ceil(len(pupil_x1ds)/6))
# Add labels to the subplots
if nsource == 0:
ax_cal_r.set_title('Example Transposed GR150R cutout\n(cal)')
ax_cal_c.set_title('Example GR150C cutout\n(cal)')
ax_i2d.set_title('Direct Image\n(i2d)')
ax_x1d.set_title('All Collapsed 1-D Spectrum\n(level 2 x1d)')
ax_i2d.set_ylabel(f'Source\n{source_id}', fontsize=15)
ax_cal_r.set_xlabel('dispersion --->')
ax_cal_c.set_xlabel('dispersion --->')
ax_x1d.set_xlabel('Wavelength (microns)')
ax_x1d.set_ylabel('F_nu (Jy)')
ax_x1d.ticklabel_format(axis='y', style='sci', scilimits=(0, 0)) # forcing scientific notation for the spectra
fig.tight_layout()
fig.show()
Extension 435 in jw02079004003_03101_00001_nis_cal.fits contains the data for source 417 from our catalog
Extension 428 in jw02079004003_05101_00001_nis_cal.fits contains the data for source 417 from our catalog
Extension 211 in jw02079004003_03101_00001_nis_cal.fits contains the data for source 567 from our catalog
Extension 204 in jw02079004003_05101_00001_nis_cal.fits contains the data for source 567 from our catalog
Extension 337 in jw02079004003_03101_00001_nis_cal.fits contains the data for source 347 from our catalog
Extension 330 in jw02079004003_05101_00001_nis_cal.fits contains the data for source 347 from our catalog
Extension 218 in jw02079004003_03101_00001_nis_cal.fits contains the data for source 1296 from our catalog
Extension 211 in jw02079004003_05101_00001_nis_cal.fits contains the data for source 1296 from our catalog
Extension 64 in jw02079004003_03101_00001_nis_cal.fits contains the data for source 606 from our catalog
Extension 57 in jw02079004003_05101_00001_nis_cal.fits contains the data for source 606 from our catalog

10. Spec3 Pipeline#
NIRISS WFSS data are minimally processed through the Spec3 stage of the pipeline to combine calibrated data from multiple dithers within an observation. The spec3 products are unique for a specific grism and blocking filter combination; the different grism data are not combined by default. As of pipeline version 1.19.1, the level 3 source-based *_cal.fits
files created in this step in the exp_to_source step are no longer saved by default, and the *_x1d.fits
files created in the extract_1d and the *_c1d.fits
files created in the combine_1d step are now saved as a single file per grism and filter combination with all of the extracted sources contained within that file.
time_spec3 = time.perf_counter()
# Find the cal.fits files
sstring = os.path.join(spec2_dir, 'jw*cal.fits')
spec2_cal_files = sorted(glob.glob(sstring))
for ii, cal_relpath in enumerate(spec2_cal_files):
spec2_cal_files[ii] = os.path.abspath(cal_relpath)
spec2_cal_files = np.array(spec2_cal_files)
print(f'Found {str(len(spec2_cal_files))} grism spectroscopy cal files to process for level 3')
Found 6 grism spectroscopy cal files to process for level 3
Create Spec3 Association Files#
There will be one spec3 association per blocking filter and grism combination, in which all of the extracted 1-D spectra within an observation with that filter and grism combination are coadded into a single spectrum for each source. If using only one blocking filter (e.g., F200W) with both grisms (GR150R & GR150C) for example, we would expect two spec3 association files, each of which contains all of the corresponding cal.fits files to combine.
Like with Image3 and Spec2 before, we will be creating Image3 associations by providing a list of exposures that we have processed through the pipeline and saved in separate directories rather than downloading directly from MAST or using the pool files. Note that the output products will have a rootname that is specified by the product_name
in the association file. For this tutorial, the rootname of the output products will end with _spec3_asn.json
.
# Create Level 3 Associations for each pupil (blocking filter) type
if dospec3:
# Parameters to be used for the NIRISS spec3 association creation
spec3_pid = str(program) # associations are only set up to combine for the same program & observation
spec3_obs = str(sci_observtn) # associations are only set up to combine for the same program & observation
spec3_ins = 'NIRISS'
# Identify the unique filters & grisms used for the NIRISS WFSS cal files
spec3_dict = {}
spec3_dict['PUPIL'] = np.array([fits.getval(cf, 'PUPIL') for cf in spec2_cal_files])
spec3_dict['FILTER'] = np.array([fits.getval(cf, 'FILTER') for cf in spec2_cal_files])
spec3_dict['PATHNAMES'] = np.array(spec2_cal_files)
spec3_df = pd.DataFrame(spec3_dict)
# Loop over unique pupil values
for spec3_filter in spec3_df['PUPIL'].unique():
# Loop over unique filter values
for spec3_grism in spec3_df['FILTER'].unique():
# find the files specific to each of the filters & grisms
spec3_files = spec3_df[(spec3_df['PUPIL'] == spec3_filter) & (spec3_df['FILTER'] == spec3_grism)]['PATHNAMES']
# build the association names to match the default names from the pipeline
product_name = f"jw{spec3_pid}-o{spec3_obs}_{spec3_ins}_{spec3_grism}-{spec3_filter}".lower()
spec3_asn_filename = product_name + '_spec3_asn.json'
spec3_association = asn_from_list.asn_from_list(spec3_files, rule=DMS_Level3_Base,
product_name=product_name)
spec3_association.data['asn_type'] = 'spec3'
spec3_association.data['program'] = spec3_pid
# Format association as .json file
_, serialized = spec3_association.dump(format="json")
# Write out association file
association_spec3 = os.path.join(sci_dir, spec3_asn_filename)
with open(association_spec3, "w") as fd:
fd.write(serialized)
print(f'Writing spec3 association: {association_spec3}')
Writing spec3 association: /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/jw02079-o004_niriss_gr150r-f200w_spec3_asn.json
Writing spec3 association: /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/jw02079-o004_niriss_gr150c-f200w_spec3_asn.json
Take a quick look at the contents of the first spec3 association file to get a feel for what is being associated
if dospec3:
spec3_asns = glob.glob(os.path.join(sci_dir, "*spec3_asn.json"))
# open the image3 association to look at
spec3_asn_data = json.load(open(spec3_asns[0]))
print(f'asn_type : {spec3_asn_data["asn_type"]}')
print(f'code_version : {spec3_asn_data["code_version"]}')
# in particular, take a closer look at the product filenames with the association file:
for product in spec3_asn_data['products']:
for key, value in product.items():
if key == 'members':
print(f"{key}:")
for member in value:
print(f" {member['expname']} {member['exptype']}")
else:
print(f"{key}: {value}")
asn_type : spec3
code_version : 1.19.1
name: jw02079-o004_niriss_gr150r-f200w
members:
/home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage2_spec/jw02079004003_03101_00001_nis_cal.fits science
/home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage2_spec/jw02079004003_03101_00002_nis_cal.fits science
/home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage2_spec/jw02079004003_03101_00003_nis_cal.fits science
Run Spec3#
In Spec3, the *_cal.fits
files are reorganized based on source number from the Image3 Pipeline’s source catalog, extracted into level 3 *_x1d.fits
files, and then combined into a single 1-D spectrum (*_c1d.fits
files) for each source. The parameters in each of the Spec3 steps can be modified from the default values, including overwriting reference files that are used during this stage. This dictionary of the modified parameters for each of the steps is then fed into the steps
parameter of the Spec3Pipeline
call. The syntax for modifying some of these parameters is below.
# Set up a dictionary to define how the Spec3 pipeline should be configured.
# this sets up any entry to spec3dict to be a dictionary itself
spec3dict = defaultdict(dict)
# -----------------------------Set step parameters------------------------------
# Overrides for whether or not certain steps should be skipped (example).
# spec3dict['pixel_replace']['skip'] = True
# Run Stage 3
if dospec3:
for spec3_asn in spec3_asns:
os.chdir(spec3_dir)
spec3 = Spec3Pipeline.call(spec3_asn, output_dir=spec3_dir, steps=spec3dict, save_results=True)
os.chdir(cwd) # change back into the directory you started in
else:
print('Skipping Spec3 processing')
2025-09-13 16:47:22,699 - stpipe.Spec3Pipeline - INFO - Spec3Pipeline instance created.
2025-09-13 16:47:22,700 - stpipe.Spec3Pipeline.assign_mtwcs - INFO - AssignMTWcsStep instance created.
2025-09-13 16:47:22,701 - stpipe.Spec3Pipeline.master_background - INFO - MasterBackgroundStep instance created.
2025-09-13 16:47:22,702 - stpipe.Spec3Pipeline.mrs_imatch - INFO - MRSIMatchStep instance created.
2025-09-13 16:47:22,703 - stpipe.Spec3Pipeline.outlier_detection - INFO - OutlierDetectionStep instance created.
2025-09-13 16:47:22,704 - stpipe.Spec3Pipeline.pixel_replace - INFO - PixelReplaceStep instance created.
2025-09-13 16:47:22,705 - stpipe.Spec3Pipeline.resample_spec - INFO - ResampleSpecStep instance created.
2025-09-13 16:47:22,706 - stpipe.Spec3Pipeline.cube_build - INFO - CubeBuildStep instance created.
2025-09-13 16:47:22,708 - stpipe.Spec3Pipeline.extract_1d - INFO - Extract1dStep instance created.
2025-09-13 16:47:22,709 - stpipe.Spec3Pipeline.photom - INFO - PhotomStep instance created.
2025-09-13 16:47:22,709 - stpipe.Spec3Pipeline.combine_1d - INFO - Combine1dStep instance created.
2025-09-13 16:47:22,710 - stpipe.Spec3Pipeline.spectral_leak - INFO - SpectralLeakStep instance created.
2025-09-13 16:47:23,133 - stpipe.Spec3Pipeline - INFO - Step Spec3Pipeline running with args ('/home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/jw02079-o004_niriss_gr150r-f200w_spec3_asn.json',).
2025-09-13 16:47:23,149 - stpipe.Spec3Pipeline - INFO - Step Spec3Pipeline parameters are:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage3_spec
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: True
skip: False
suffix: None
search_output_file: True
input_dir: ''
steps:
assign_mtwcs:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: True
output_use_index: True
save_results: False
skip: False
suffix: assign_mtwcs
search_output_file: True
input_dir: ''
master_background:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: True
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
median_kernel: 1
user_background: None
save_background: False
force_subtract: False
mrs_imatch:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: True
suffix: None
search_output_file: True
input_dir: ''
bkg_degree: 1
subtract: False
outlier_detection:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: False
input_dir: ''
weight_type: ivm
pixfrac: 1.0
kernel: square
fillval: NAN
maskpt: 0.7
snr: 5.0 4.0
scale: 1.2 0.7
backg: 0.0
kernel_size: 7 7
threshold_percent: 99.8
rolling_window_width: 25
ifu_second_check: False
save_intermediate_results: False
resample_data: True
good_bits: ~DO_NOT_USE
in_memory: True
pixel_replace:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: True
output_use_index: True
save_results: False
skip: True
suffix: None
search_output_file: True
input_dir: ''
algorithm: fit_profile
n_adjacent_cols: 3
resample_spec:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
pixfrac: 1.0
kernel: square
fillval: NAN
weight_type: ivm
output_shape: None
pixel_scale_ratio: 1.0
pixel_scale: None
output_wcs: ''
single: False
blendheaders: True
in_memory: True
cube_build:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: True
output_use_index: True
save_results: False
skip: False
suffix: s3d
search_output_file: False
input_dir: ''
channel: all
band: all
grating: all
filter: all
output_type: None
scalexy: 0.0
scalew: 0.0
weighting: drizzle
coord_system: skyalign
ra_center: None
dec_center: None
cube_pa: None
nspax_x: None
nspax_y: None
rois: 0.0
roiw: 0.0
weight_power: 2.0
wavemin: None
wavemax: None
single: False
skip_dqflagging: False
offset_file: None
debug_spaxel: -1 -1 -1
extract_1d:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
subtract_background: None
apply_apcorr: True
extraction_type: box
use_source_posn: None
position_offset: 0.0
model_nod_pair: True
optimize_psf_location: True
smoothing_length: None
bkg_fit: None
bkg_order: None
log_increment: 50
save_profile: False
save_scene_model: False
save_residual_image: False
center_xy: None
ifu_autocen: False
bkg_sigma_clip: 3.0
ifu_rfcorr: True
ifu_set_srctype: None
ifu_rscale: None
ifu_covar_scale: 1.0
soss_atoca: True
soss_threshold: 0.01
soss_n_os: 2
soss_wave_grid_in: None
soss_wave_grid_out: None
soss_estimate: None
soss_rtol: 0.0001
soss_max_grid_size: 20000
soss_tikfac: None
soss_width: 40.0
soss_bad_pix: masking
soss_modelname: None
photom:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
inverse: False
source_type: None
mrs_time_correction: True
combine_1d:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
exptime_key: exposure_time
sigma_clip: None
spectral_leak:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
2025-09-13 16:47:27,227 - stpipe.Spec3Pipeline - INFO - Prefetching reference files for dataset: 'jw02079-o004_niriss_gr150r-f200w_spec3_asn.json' reftypes = ['apcorr', 'area', 'cubepar', 'extract1d', 'mrsptcorr', 'pastasoss', 'photom', 'psf', 'speckernel', 'specprofile']
2025-09-13 16:47:27,252 - stpipe.Spec3Pipeline - INFO - Prefetch for APCORR reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits'.
2025-09-13 16:47:27,253 - stpipe.Spec3Pipeline - INFO - Prefetch for AREA reference file is 'N/A'.
2025-09-13 16:47:27,253 - stpipe.Spec3Pipeline - INFO - Prefetch for CUBEPAR reference file is 'N/A'.
2025-09-13 16:47:27,253 - stpipe.Spec3Pipeline - INFO - Prefetch for EXTRACT1D reference file is 'N/A'.
2025-09-13 16:47:27,254 - stpipe.Spec3Pipeline - INFO - Prefetch for MRSPTCORR reference file is 'N/A'.
2025-09-13 16:47:27,254 - stpipe.Spec3Pipeline - INFO - Prefetch for PASTASOSS reference file is 'N/A'.
2025-09-13 16:47:27,254 - stpipe.Spec3Pipeline - INFO - Prefetch for PHOTOM reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_photom_0041.fits'.
2025-09-13 16:47:27,255 - stpipe.Spec3Pipeline - INFO - Prefetch for PSF reference file is 'N/A'.
2025-09-13 16:47:27,255 - stpipe.Spec3Pipeline - INFO - Prefetch for SPECKERNEL reference file is 'N/A'.
2025-09-13 16:47:27,256 - stpipe.Spec3Pipeline - INFO - Prefetch for SPECPROFILE reference file is 'N/A'.
2025-09-13 16:47:27,256 - stpipe.Spec3Pipeline - INFO - Starting calwebb_spec3 ...
2025-09-13 16:47:53,866 - stpipe.Spec3Pipeline - INFO - Convert from exposure-based to source-based data.
2025-09-13 16:47:53,867 - jwst.exp_to_source.exp_to_source - INFO - Reorganizing data from exposure jw02079004003_03101_00001_nis_cal.fits
2025-09-13 16:48:01,829 - jwst.exp_to_source.exp_to_source - INFO - Reorganizing data from exposure jw02079004003_03101_00002_nis_cal.fits
2025-09-13 16:48:04,374 - jwst.exp_to_source.exp_to_source - INFO - Reorganizing data from exposure jw02079004003_03101_00003_nis_cal.fits
2025-09-13 16:48:10,902 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faef826a900>,).
2025-09-13 16:48:10,902 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 16:48:11,962 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faef826a900>,).
2025-09-13 16:48:11,971 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 16:48:12,001 - jwst.extract_1d.extract - INFO - Working on slit 8
2025-09-13 16:48:12,002 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type POINT
2025-09-13 16:48:12,003 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 10.00 (inclusive)
2025-09-13 16:48:12,009 - jwst.extract_1d.extract - INFO - Creating aperture correction.
2025-09-13 16:48:12,066 - jwst.extract_1d.extract - INFO - Working on slit 8
2025-09-13 16:48:12,067 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type POINT
2025-09-13 16:48:12,067 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 10.00 (inclusive)
2025-09-13 16:48:12,074 - jwst.extract_1d.extract - INFO - Creating aperture correction.
2025-09-13 16:48:12,208 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 16:48:13,221 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_03101_00001_nis_cal.fits>,).
2025-09-13 16:48:13,272 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 16:48:13,273 - jwst.combine_1d.combine1d - WARNING - Input spectrum 8 order 1 from group_id jw02079004003_03101_1_1 has no valid flux values; skipping.
2025-09-13 16:48:13,273 - jwst.combine_1d.combine1d - WARNING - Input spectrum 8 order 1 from group_id jw02079004003_03101_2_1 has no valid flux values; skipping.
2025-09-13 16:48:13,273 - jwst.combine_1d.combine1d - ERROR - No valid input spectra found for source. Skipping.
2025-09-13 16:48:13,282 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 16:48:14,345 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faeba210cd0>,).
2025-09-13 16:48:14,345 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 16:48:15,459 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faeba210cd0>,).
2025-09-13 16:48:15,463 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 16:48:15,493 - jwst.extract_1d.extract - INFO - Working on slit 522
2025-09-13 16:48:15,495 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:48:15,496 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 146.00 (inclusive)
2025-09-13 16:48:15,551 - jwst.extract_1d.extract - INFO - Working on slit 522
2025-09-13 16:48:15,552 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:48:15,554 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 146.00 (inclusive)
2025-09-13 16:48:15,607 - jwst.extract_1d.extract - INFO - Working on slit 522
2025-09-13 16:48:15,608 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:48:15,610 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 147.00 (inclusive)
2025-09-13 16:48:15,754 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 16:48:16,804 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_03101_00001_nis_cal.fits>,).
2025-09-13 16:48:16,872 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 16:48:16,899 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 16:48:16,900 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 16:48:16,902 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 16:48:16,903 - jwst.combine_1d.combine1d - WARNING - 3 output pixel numbers were NaN
2025-09-13 16:48:16,904 - jwst.combine_1d.combine1d - WARNING - 148 elements of output had no corresponding input data;
2025-09-13 16:48:16,904 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 16:48:16,955 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 16:48:18,002 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faeba211090>,).
2025-09-13 16:48:18,003 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 16:48:19,039 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faeba211090>,).
2025-09-13 16:48:19,043 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 16:48:19,073 - jwst.extract_1d.extract - INFO - Working on slit 796
2025-09-13 16:48:19,074 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:48:19,075 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 94.00 (inclusive)
2025-09-13 16:48:19,128 - jwst.extract_1d.extract - INFO - Working on slit 796
2025-09-13 16:48:19,130 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:48:19,131 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 93.00 (inclusive)
2025-09-13 16:48:19,183 - jwst.extract_1d.extract - INFO - Working on slit 796
2025-09-13 16:48:19,184 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:48:19,186 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 94.00 (inclusive)
2025-09-13 16:48:19,330 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 16:48:20,398 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_03101_00001_nis_cal.fits>,).
2025-09-13 16:48:20,469 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 16:48:20,489 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 16:48:20,491 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 16:48:20,492 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 16:48:20,493 - jwst.combine_1d.combine1d - WARNING - 2 output pixel numbers were NaN
2025-09-13 16:48:20,493 - jwst.combine_1d.combine1d - WARNING - 96 elements of output had no corresponding input data;
2025-09-13 16:48:20,494 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 16:48:20,543 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 16:48:21,609 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faebda39ba0>,).
2025-09-13 16:48:21,610 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 16:48:22,679 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faebda39ba0>,).
2025-09-13 16:48:22,682 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 16:48:22,713 - jwst.extract_1d.extract - INFO - Working on slit 1479
2025-09-13 16:48:22,714 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:48:22,715 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 102.00 (inclusive)
2025-09-13 16:48:22,769 - jwst.extract_1d.extract - INFO - Working on slit 1479
2025-09-13 16:48:22,770 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:48:22,771 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 102.00 (inclusive)
2025-09-13 16:48:22,824 - jwst.extract_1d.extract - INFO - Working on slit 1479
2025-09-13 16:48:22,825 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:48:22,826 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 101.00 (inclusive)
2025-09-13 16:48:22,969 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 16:48:24,006 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_03101_00001_nis_cal.fits>,).
2025-09-13 16:48:24,076 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 16:48:24,093 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 16:48:24,095 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 16:48:24,096 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 16:48:24,097 - jwst.combine_1d.combine1d - WARNING - 1 output pixel numbers were NaN
2025-09-13 16:48:24,098 - jwst.combine_1d.combine1d - WARNING - 51 elements of output had no corresponding input data;
2025-09-13 16:48:24,098 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 16:48:24,145 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 16:48:25,174 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faebda38050>,).
2025-09-13 16:48:25,175 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 16:48:26,216 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faebda38050>,).
2025-09-13 16:48:26,219 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 16:48:26,249 - jwst.extract_1d.extract - INFO - Working on slit 214
2025-09-13 16:48:26,250 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:48:26,251 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 84.00 (inclusive)
2025-09-13 16:48:26,304 - jwst.extract_1d.extract - INFO - Working on slit 214
2025-09-13 16:48:26,306 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:48:26,307 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 84.00 (inclusive)
2025-09-13 16:48:26,360 - jwst.extract_1d.extract - INFO - Working on slit 214
2025-09-13 16:48:26,361 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:48:26,362 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 84.00 (inclusive)
2025-09-13 16:48:26,505 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 16:48:27,525 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_03101_00001_nis_cal.fits>,).
2025-09-13 16:48:27,593 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 16:48:27,614 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 16:48:27,616 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 16:48:27,617 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 16:48:27,619 - jwst.combine_1d.combine1d - WARNING - 2 output pixel numbers were NaN
2025-09-13 16:48:27,619 - jwst.combine_1d.combine1d - WARNING - 105 elements of output had no corresponding input data;
2025-09-13 16:48:27,619 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 16:48:27,666 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 16:48:28,738 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faee9585370>,).
2025-09-13 16:48:28,739 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 16:48:29,808 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faee9585370>,).
2025-09-13 16:48:29,811 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 16:48:29,841 - jwst.extract_1d.extract - INFO - Working on slit 693
2025-09-13 16:48:29,842 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:48:29,843 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 70.00 (inclusive)
2025-09-13 16:48:29,898 - jwst.extract_1d.extract - INFO - Working on slit 693
2025-09-13 16:48:29,899 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:48:29,900 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 71.00 (inclusive)
2025-09-13 16:48:29,954 - jwst.extract_1d.extract - INFO - Working on slit 693
2025-09-13 16:48:29,955 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:48:29,956 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 70.00 (inclusive)
2025-09-13 16:48:30,101 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 16:48:31,130 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_03101_00001_nis_cal.fits>,).
2025-09-13 16:48:31,200 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 16:48:31,220 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 16:48:31,221 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 16:48:31,222 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 16:48:31,223 - jwst.combine_1d.combine1d - WARNING - 2 output pixel numbers were NaN
2025-09-13 16:48:31,224 - jwst.combine_1d.combine1d - WARNING - 75 elements of output had no corresponding input data;
2025-09-13 16:48:31,224 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 16:48:31,271 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 16:48:32,302 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faebb0658c0>,).
2025-09-13 16:48:32,302 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 16:48:33,333 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faebb0658c0>,).
2025-09-13 16:48:33,336 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 16:48:33,367 - jwst.extract_1d.extract - INFO - Working on slit 1120
2025-09-13 16:48:33,368 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:48:33,369 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 108.00 (inclusive)
2025-09-13 16:48:33,422 - jwst.extract_1d.extract - INFO - Working on slit 1120
2025-09-13 16:48:33,423 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:48:33,424 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 109.00 (inclusive)
2025-09-13 16:48:33,478 - jwst.extract_1d.extract - INFO - Working on slit 1120
2025-09-13 16:48:33,479 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:48:33,480 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 108.00 (inclusive)
2025-09-13 16:48:33,626 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 16:48:34,680 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_03101_00001_nis_cal.fits>,).
2025-09-13 16:48:34,750 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 16:48:34,770 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 16:48:34,771 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 16:48:34,772 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 16:48:34,774 - jwst.combine_1d.combine1d - WARNING - 2 output pixel numbers were NaN
2025-09-13 16:48:34,774 - jwst.combine_1d.combine1d - WARNING - 69 elements of output had no corresponding input data;
2025-09-13 16:48:34,775 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 16:48:34,822 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 16:48:35,935 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faebb064050>,).
2025-09-13 16:48:35,936 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 16:48:37,045 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faebb064050>,).
2025-09-13 16:48:37,049 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 16:48:37,080 - jwst.extract_1d.extract - INFO - Working on slit 1257
2025-09-13 16:48:37,081 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:48:37,082 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 102.00 (inclusive)
2025-09-13 16:48:37,139 - jwst.extract_1d.extract - INFO - Working on slit 1257
2025-09-13 16:48:37,140 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:48:37,142 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 103.00 (inclusive)
2025-09-13 16:48:37,195 - jwst.extract_1d.extract - INFO - Working on slit 1257
2025-09-13 16:48:37,196 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:48:37,197 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 102.00 (inclusive)
2025-09-13 16:48:37,342 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 16:48:38,374 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_03101_00001_nis_cal.fits>,).
2025-09-13 16:48:38,446 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 16:48:38,466 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 16:48:38,468 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 16:48:38,469 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 16:48:38,471 - jwst.combine_1d.combine1d - WARNING - 3 output pixel numbers were NaN
2025-09-13 16:48:38,471 - jwst.combine_1d.combine1d - WARNING - 78 elements of output had no corresponding input data;
2025-09-13 16:48:38,472 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 16:48:38,521 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 16:48:39,578 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faeb5f43e50>,).
2025-09-13 16:48:39,579 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 16:48:40,624 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faeb5f43e50>,).
2025-09-13 16:48:40,627 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 16:48:40,657 - jwst.extract_1d.extract - INFO - Working on slit 766
2025-09-13 16:48:40,658 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:48:40,659 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 52.00 (inclusive)
2025-09-13 16:48:40,713 - jwst.extract_1d.extract - INFO - Working on slit 766
2025-09-13 16:48:40,715 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:48:40,716 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 52.00 (inclusive)
2025-09-13 16:48:40,769 - jwst.extract_1d.extract - INFO - Working on slit 766
2025-09-13 16:48:40,770 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:48:40,771 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 51.00 (inclusive)
2025-09-13 16:48:40,920 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 16:48:41,987 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_03101_00001_nis_cal.fits>,).
2025-09-13 16:48:42,057 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 16:48:42,078 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 16:48:42,080 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 16:48:42,081 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 16:48:42,082 - jwst.combine_1d.combine1d - WARNING - 2 output pixel numbers were NaN
2025-09-13 16:48:42,083 - jwst.combine_1d.combine1d - WARNING - 105 elements of output had no corresponding input data;
2025-09-13 16:48:42,083 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 16:48:42,130 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 16:48:43,190 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faee56a0350>,).
2025-09-13 16:48:43,191 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 16:48:44,251 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faee56a0350>,).
2025-09-13 16:48:44,255 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 16:48:44,286 - jwst.extract_1d.extract - INFO - Working on slit 606
2025-09-13 16:48:44,287 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type POINT
2025-09-13 16:48:44,288 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 10.00 (inclusive)
2025-09-13 16:48:44,295 - jwst.extract_1d.extract - INFO - Creating aperture correction.
2025-09-13 16:48:44,431 - jwst.extract_1d.extract - INFO - Working on slit 606
2025-09-13 16:48:44,432 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type POINT
2025-09-13 16:48:44,433 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 10.00 (inclusive)
2025-09-13 16:48:44,440 - jwst.extract_1d.extract - INFO - Creating aperture correction.
2025-09-13 16:48:44,575 - jwst.extract_1d.extract - INFO - Working on slit 606
2025-09-13 16:48:44,576 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type POINT
2025-09-13 16:48:44,577 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 10.00 (inclusive)
2025-09-13 16:48:44,583 - jwst.extract_1d.extract - INFO - Creating aperture correction.
2025-09-13 16:48:44,814 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 16:48:45,929 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_03101_00001_nis_cal.fits>,).
2025-09-13 16:48:45,998 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 16:48:46,017 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 16:48:46,019 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 16:48:46,020 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 16:48:46,021 - jwst.combine_1d.combine1d - WARNING - 2 output pixel numbers were NaN
2025-09-13 16:48:46,021 - jwst.combine_1d.combine1d - WARNING - 63 elements of output had no corresponding input data;
2025-09-13 16:48:46,022 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 16:48:46,069 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 16:48:47,127 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faef8022120>,).
2025-09-13 16:48:47,128 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 16:48:48,157 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faef8022120>,).
2025-09-13 16:48:48,160 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 16:48:48,190 - jwst.extract_1d.extract - INFO - Working on slit 649
2025-09-13 16:48:48,191 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:48:48,192 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 89.00 (inclusive)
2025-09-13 16:48:48,245 - jwst.extract_1d.extract - INFO - Working on slit 649
2025-09-13 16:48:48,246 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:48:48,247 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 90.00 (inclusive)
2025-09-13 16:48:48,300 - jwst.extract_1d.extract - INFO - Working on slit 649
2025-09-13 16:48:48,302 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:48:48,303 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 89.00 (inclusive)
2025-09-13 16:48:48,445 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 16:48:49,469 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_03101_00001_nis_cal.fits>,).
2025-09-13 16:48:49,539 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 16:48:49,559 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 16:48:49,560 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 16:48:49,562 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 16:48:49,563 - jwst.combine_1d.combine1d - WARNING - 3 output pixel numbers were NaN
2025-09-13 16:48:49,563 - jwst.combine_1d.combine1d - WARNING - 96 elements of output had no corresponding input data;
2025-09-13 16:48:49,564 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 16:48:49,612 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 16:48:50,681 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faef8023110>,).
2025-09-13 16:48:50,682 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 16:48:51,759 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faef8023110>,).
2025-09-13 16:48:51,763 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 16:48:51,793 - jwst.extract_1d.extract - INFO - Working on slit 982
2025-09-13 16:48:51,794 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:48:51,795 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 49.00 (inclusive)
2025-09-13 16:48:51,849 - jwst.extract_1d.extract - INFO - Working on slit 982
2025-09-13 16:48:51,850 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:48:51,851 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 48.00 (inclusive)
2025-09-13 16:48:51,905 - jwst.extract_1d.extract - INFO - Working on slit 982
2025-09-13 16:48:51,907 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:48:51,907 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 48.00 (inclusive)
2025-09-13 16:48:52,053 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 16:48:53,098 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_03101_00001_nis_cal.fits>,).
2025-09-13 16:48:53,170 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 16:48:53,189 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 16:48:53,190 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 16:48:53,191 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 16:48:53,193 - jwst.combine_1d.combine1d - WARNING - 2 output pixel numbers were NaN
2025-09-13 16:48:53,193 - jwst.combine_1d.combine1d - WARNING - 57 elements of output had no corresponding input data;
2025-09-13 16:48:53,194 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 16:48:53,241 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 16:48:54,282 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faec0abc670>,).
2025-09-13 16:48:54,283 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 16:48:55,324 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faec0abc670>,).
2025-09-13 16:48:55,327 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 16:48:55,357 - jwst.extract_1d.extract - INFO - Working on slit 1364
2025-09-13 16:48:55,358 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:48:55,359 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 44.00 (inclusive)
2025-09-13 16:48:55,412 - jwst.extract_1d.extract - INFO - Working on slit 1364
2025-09-13 16:48:55,413 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:48:55,414 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 43.00 (inclusive)
2025-09-13 16:48:55,467 - jwst.extract_1d.extract - INFO - Working on slit 1364
2025-09-13 16:48:55,468 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:48:55,469 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 43.00 (inclusive)
2025-09-13 16:48:55,615 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 16:48:56,689 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_03101_00001_nis_cal.fits>,).
2025-09-13 16:48:56,759 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 16:48:56,778 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 16:48:56,780 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 16:48:56,781 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 16:48:56,782 - jwst.combine_1d.combine1d - WARNING - 3 output pixel numbers were NaN
2025-09-13 16:48:56,783 - jwst.combine_1d.combine1d - WARNING - 60 elements of output had no corresponding input data;
2025-09-13 16:48:56,783 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 16:48:56,831 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 16:48:57,916 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faebd79b850>,).
2025-09-13 16:48:57,917 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 16:48:59,003 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faebd79b850>,).
2025-09-13 16:48:59,007 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 16:48:59,036 - jwst.extract_1d.extract - INFO - Working on slit 898
2025-09-13 16:48:59,037 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type POINT
2025-09-13 16:48:59,038 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 10.00 (inclusive)
2025-09-13 16:48:59,045 - jwst.extract_1d.extract - INFO - Creating aperture correction.
2025-09-13 16:48:59,195 - jwst.extract_1d.extract - INFO - Working on slit 898
2025-09-13 16:48:59,196 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type POINT
2025-09-13 16:48:59,197 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 10.00 (inclusive)
2025-09-13 16:48:59,203 - jwst.extract_1d.extract - INFO - Creating aperture correction.
2025-09-13 16:48:59,353 - jwst.extract_1d.extract - INFO - Working on slit 898
2025-09-13 16:48:59,354 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type POINT
2025-09-13 16:48:59,355 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 10.00 (inclusive)
2025-09-13 16:48:59,362 - jwst.extract_1d.extract - INFO - Creating aperture correction.
2025-09-13 16:48:59,605 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 16:49:00,626 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_03101_00001_nis_cal.fits>,).
2025-09-13 16:49:00,693 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 16:49:00,712 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 16:49:00,714 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 16:49:00,715 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 16:49:00,717 - jwst.combine_1d.combine1d - WARNING - 3 output pixel numbers were NaN
2025-09-13 16:49:00,717 - jwst.combine_1d.combine1d - WARNING - 93 elements of output had no corresponding input data;
2025-09-13 16:49:00,717 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 16:49:00,763 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 16:49:01,760 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faebe2ac050>,).
2025-09-13 16:49:01,761 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 16:49:02,797 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faebe2ac050>,).
2025-09-13 16:49:02,800 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 16:49:02,830 - jwst.extract_1d.extract - INFO - Working on slit 1049
2025-09-13 16:49:02,831 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:49:02,832 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 16.00 (inclusive)
2025-09-13 16:49:02,884 - jwst.extract_1d.extract - INFO - Working on slit 1049
2025-09-13 16:49:02,886 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:49:02,886 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 24.00 (inclusive)
2025-09-13 16:49:02,938 - jwst.extract_1d.extract - INFO - Working on slit 1049
2025-09-13 16:49:02,939 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:49:02,940 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 7.00 (inclusive)
2025-09-13 16:49:03,084 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 16:49:04,121 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_03101_00001_nis_cal.fits>,).
2025-09-13 16:49:04,191 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 16:49:04,211 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 16:49:04,212 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 16:49:04,213 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 16:49:04,215 - jwst.combine_1d.combine1d - WARNING - 2 output pixel numbers were NaN
2025-09-13 16:49:04,216 - jwst.combine_1d.combine1d - WARNING - 75 elements of output had no corresponding input data;
2025-09-13 16:49:04,216 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 16:49:04,263 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 16:49:05,360 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faec1553590>,).
2025-09-13 16:49:05,361 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 16:49:06,401 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faec1553590>,).
2025-09-13 16:49:06,404 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 16:49:06,433 - jwst.extract_1d.extract - INFO - Working on slit 732
2025-09-13 16:49:06,434 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:49:06,435 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 64.00 (inclusive)
2025-09-13 16:49:06,488 - jwst.extract_1d.extract - INFO - Working on slit 732
2025-09-13 16:49:06,489 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:49:06,490 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 65.00 (inclusive)
2025-09-13 16:49:06,541 - jwst.extract_1d.extract - INFO - Working on slit 732
2025-09-13 16:49:06,542 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:49:06,543 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 64.00 (inclusive)
2025-09-13 16:49:06,684 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 16:49:07,700 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_03101_00001_nis_cal.fits>,).
2025-09-13 16:49:07,767 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 16:49:07,784 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 16:49:07,786 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 16:49:07,787 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 16:49:07,788 - jwst.combine_1d.combine1d - WARNING - 2 output pixel numbers were NaN
2025-09-13 16:49:07,788 - jwst.combine_1d.combine1d - WARNING - 45 elements of output had no corresponding input data;
2025-09-13 16:49:07,789 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 16:49:07,834 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 16:49:08,868 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faec1553dd0>,).
2025-09-13 16:49:08,869 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 16:49:09,899 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faec1553dd0>,).
2025-09-13 16:49:09,903 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 16:49:09,932 - jwst.extract_1d.extract - INFO - Working on slit 189
2025-09-13 16:49:09,933 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:49:09,934 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 48.00 (inclusive)
2025-09-13 16:49:09,986 - jwst.extract_1d.extract - INFO - Working on slit 189
2025-09-13 16:49:09,987 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:49:09,987 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 47.00 (inclusive)
2025-09-13 16:49:10,039 - jwst.extract_1d.extract - INFO - Working on slit 189
2025-09-13 16:49:10,040 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:49:10,041 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 47.00 (inclusive)
2025-09-13 16:49:10,181 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 16:49:11,210 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_03101_00001_nis_cal.fits>,).
2025-09-13 16:49:11,279 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 16:49:11,296 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 16:49:11,297 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 16:49:11,298 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 16:49:11,300 - jwst.combine_1d.combine1d - WARNING - 1 output pixel numbers were NaN
2025-09-13 16:49:11,300 - jwst.combine_1d.combine1d - WARNING - 37 elements of output had no corresponding input data;
2025-09-13 16:49:11,300 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 16:49:11,347 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 16:49:12,385 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faebdb1ec50>,).
2025-09-13 16:49:12,386 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 16:49:13,444 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faebdb1ec50>,).
2025-09-13 16:49:13,447 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 16:49:13,477 - jwst.extract_1d.extract - INFO - Working on slit 881
2025-09-13 16:49:13,478 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type POINT
2025-09-13 16:49:13,479 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 10.00 (inclusive)
2025-09-13 16:49:13,485 - jwst.extract_1d.extract - INFO - Creating aperture correction.
2025-09-13 16:49:13,621 - jwst.extract_1d.extract - INFO - Working on slit 881
2025-09-13 16:49:13,623 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type POINT
2025-09-13 16:49:13,623 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 10.00 (inclusive)
2025-09-13 16:49:13,630 - jwst.extract_1d.extract - INFO - Creating aperture correction.
2025-09-13 16:49:13,768 - jwst.extract_1d.extract - INFO - Working on slit 881
2025-09-13 16:49:13,769 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type POINT
2025-09-13 16:49:13,770 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 10.00 (inclusive)
2025-09-13 16:49:13,776 - jwst.extract_1d.extract - INFO - Creating aperture correction.
2025-09-13 16:49:14,004 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 16:49:15,047 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_03101_00001_nis_cal.fits>,).
2025-09-13 16:49:15,115 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 16:49:15,133 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 16:49:15,134 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 16:49:15,135 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 16:49:15,136 - jwst.combine_1d.combine1d - WARNING - 3 output pixel numbers were NaN
2025-09-13 16:49:15,137 - jwst.combine_1d.combine1d - WARNING - 63 elements of output had no corresponding input data;
2025-09-13 16:49:15,137 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 16:49:15,183 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 16:49:16,232 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faebdb1d9c0>,).
2025-09-13 16:49:16,233 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 16:49:17,311 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faebdb1d9c0>,).
2025-09-13 16:49:17,314 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 16:49:17,344 - jwst.extract_1d.extract - INFO - Working on slit 966
2025-09-13 16:49:17,345 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:49:17,346 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 54.00 (inclusive)
2025-09-13 16:49:17,398 - jwst.extract_1d.extract - INFO - Working on slit 966
2025-09-13 16:49:17,399 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:49:17,400 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 54.00 (inclusive)
2025-09-13 16:49:17,452 - jwst.extract_1d.extract - INFO - Working on slit 966
2025-09-13 16:49:17,453 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:49:17,454 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 54.00 (inclusive)
2025-09-13 16:49:17,596 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 16:49:18,634 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_03101_00001_nis_cal.fits>,).
2025-09-13 16:49:18,703 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 16:49:18,722 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 16:49:18,723 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 16:49:18,724 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 16:49:18,726 - jwst.combine_1d.combine1d - WARNING - 2 output pixel numbers were NaN
2025-09-13 16:49:18,726 - jwst.combine_1d.combine1d - WARNING - 61 elements of output had no corresponding input data;
2025-09-13 16:49:18,727 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 16:49:18,774 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 16:49:19,844 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faebc606990>,).
2025-09-13 16:49:19,845 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 16:49:20,887 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faebc606990>,).
2025-09-13 16:49:20,891 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 16:49:20,920 - jwst.extract_1d.extract - INFO - Working on slit 914
2025-09-13 16:49:20,921 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:49:20,922 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 42.00 (inclusive)
2025-09-13 16:49:20,974 - jwst.extract_1d.extract - INFO - Working on slit 914
2025-09-13 16:49:20,975 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:49:20,976 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 43.00 (inclusive)
2025-09-13 16:49:21,028 - jwst.extract_1d.extract - INFO - Working on slit 914
2025-09-13 16:49:21,029 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:49:21,029 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 43.00 (inclusive)
2025-09-13 16:49:21,171 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 16:49:22,184 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_03101_00001_nis_cal.fits>,).
2025-09-13 16:49:22,252 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 16:49:22,269 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 16:49:22,270 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 16:49:22,271 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 16:49:22,272 - jwst.combine_1d.combine1d - WARNING - 2 output pixel numbers were NaN
2025-09-13 16:49:22,273 - jwst.combine_1d.combine1d - WARNING - 32 elements of output had no corresponding input data;
2025-09-13 16:49:22,273 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 16:49:22,319 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 16:49:23,313 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faebf474d70>,).
2025-09-13 16:49:23,314 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 16:49:24,301 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faebf474d70>,).
2025-09-13 16:49:24,304 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 16:49:24,334 - jwst.extract_1d.extract - INFO - Working on slit 1084
2025-09-13 16:49:24,335 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type POINT
2025-09-13 16:49:24,336 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 10.00 (inclusive)
2025-09-13 16:49:24,343 - jwst.extract_1d.extract - INFO - Creating aperture correction.
2025-09-13 16:49:24,470 - jwst.extract_1d.extract - INFO - Working on slit 1084
2025-09-13 16:49:24,472 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type POINT
2025-09-13 16:49:24,473 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 10.00 (inclusive)
2025-09-13 16:49:24,480 - jwst.extract_1d.extract - INFO - Creating aperture correction.
2025-09-13 16:49:24,611 - jwst.extract_1d.extract - INFO - Working on slit 1084
2025-09-13 16:49:24,612 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type POINT
2025-09-13 16:49:24,613 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 10.00 (inclusive)
2025-09-13 16:49:24,620 - jwst.extract_1d.extract - INFO - Creating aperture correction.
2025-09-13 16:49:24,845 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 16:49:25,875 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_03101_00001_nis_cal.fits>,).
2025-09-13 16:49:25,944 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 16:49:25,962 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 16:49:25,964 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 16:49:25,965 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 16:49:25,966 - jwst.combine_1d.combine1d - WARNING - 3 output pixel numbers were NaN
2025-09-13 16:49:25,967 - jwst.combine_1d.combine1d - WARNING - 43 elements of output had no corresponding input data;
2025-09-13 16:49:25,967 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 16:49:26,015 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 16:49:27,075 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faec2c64200>,).
2025-09-13 16:49:27,076 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 16:49:28,090 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faec2c64200>,).
2025-09-13 16:49:28,093 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 16:49:28,123 - jwst.extract_1d.extract - INFO - Working on slit 540
2025-09-13 16:49:28,124 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:49:28,125 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 63.00 (inclusive)
2025-09-13 16:49:28,177 - jwst.extract_1d.extract - INFO - Working on slit 540
2025-09-13 16:49:28,178 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:49:28,179 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 62.00 (inclusive)
2025-09-13 16:49:28,232 - jwst.extract_1d.extract - INFO - Working on slit 540
2025-09-13 16:49:28,233 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:49:28,234 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 62.00 (inclusive)
2025-09-13 16:49:28,377 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 16:49:29,400 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_03101_00001_nis_cal.fits>,).
2025-09-13 16:49:29,470 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 16:49:29,489 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 16:49:29,490 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 16:49:29,492 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 16:49:29,493 - jwst.combine_1d.combine1d - WARNING - 2 output pixel numbers were NaN
2025-09-13 16:49:29,494 - jwst.combine_1d.combine1d - WARNING - 72 elements of output had no corresponding input data;
2025-09-13 16:49:29,494 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 16:49:29,541 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 16:49:30,595 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faec2c64170>,).
2025-09-13 16:49:30,596 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 16:49:31,662 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faec2c64170>,).
2025-09-13 16:49:31,666 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 16:49:31,696 - jwst.extract_1d.extract - INFO - Working on slit 1476
2025-09-13 16:49:31,697 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:49:31,698 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 40.00 (inclusive)
2025-09-13 16:49:31,751 - jwst.extract_1d.extract - INFO - Working on slit 1476
2025-09-13 16:49:31,752 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:49:31,753 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 49.00 (inclusive)
2025-09-13 16:49:31,805 - jwst.extract_1d.extract - INFO - Working on slit 1476
2025-09-13 16:49:31,807 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:49:31,807 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 32.00 (inclusive)
2025-09-13 16:49:31,951 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 16:49:33,027 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_03101_00001_nis_cal.fits>,).
2025-09-13 16:49:33,103 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 16:49:33,120 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 16:49:33,122 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 16:49:33,123 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 16:49:33,124 - jwst.combine_1d.combine1d - WARNING - 2 output pixel numbers were NaN
2025-09-13 16:49:33,125 - jwst.combine_1d.combine1d - WARNING - 53 elements of output had no corresponding input data;
2025-09-13 16:49:33,125 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 16:49:33,174 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 16:49:34,286 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faec2028dd0>,).
2025-09-13 16:49:34,286 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 16:49:35,369 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faec2028dd0>,).
2025-09-13 16:49:35,373 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 16:49:35,403 - jwst.extract_1d.extract - INFO - Working on slit 1142
2025-09-13 16:49:35,405 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:49:35,406 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 43.00 (inclusive)
2025-09-13 16:49:35,459 - jwst.extract_1d.extract - INFO - Working on slit 1142
2025-09-13 16:49:35,460 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:49:35,461 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 44.00 (inclusive)
2025-09-13 16:49:35,515 - jwst.extract_1d.extract - INFO - Working on slit 1142
2025-09-13 16:49:35,516 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:49:35,517 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 43.00 (inclusive)
2025-09-13 16:49:35,661 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 16:49:36,729 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_03101_00001_nis_cal.fits>,).
2025-09-13 16:49:36,799 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 16:49:36,817 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 16:49:36,819 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 16:49:36,820 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 16:49:36,822 - jwst.combine_1d.combine1d - WARNING - 3 output pixel numbers were NaN
2025-09-13 16:49:36,822 - jwst.combine_1d.combine1d - WARNING - 46 elements of output had no corresponding input data;
2025-09-13 16:49:36,823 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 16:49:36,870 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 16:49:37,921 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faec20291c0>,).
2025-09-13 16:49:37,922 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 16:49:38,984 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faec20291c0>,).
2025-09-13 16:49:38,988 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 16:49:39,017 - jwst.extract_1d.extract - INFO - Working on slit 220
2025-09-13 16:49:39,018 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type POINT
2025-09-13 16:49:39,019 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 10.00 (inclusive)
2025-09-13 16:49:39,026 - jwst.extract_1d.extract - INFO - Creating aperture correction.
2025-09-13 16:49:39,157 - jwst.extract_1d.extract - INFO - Working on slit 220
2025-09-13 16:49:39,158 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type POINT
2025-09-13 16:49:39,159 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 10.00 (inclusive)
2025-09-13 16:49:39,166 - jwst.extract_1d.extract - INFO - Creating aperture correction.
2025-09-13 16:49:39,300 - jwst.extract_1d.extract - INFO - Working on slit 220
2025-09-13 16:49:39,301 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type POINT
2025-09-13 16:49:39,302 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 10.00 (inclusive)
2025-09-13 16:49:39,309 - jwst.extract_1d.extract - INFO - Creating aperture correction.
2025-09-13 16:49:39,537 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 16:49:40,649 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_03101_00001_nis_cal.fits>,).
2025-09-13 16:49:40,718 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 16:49:40,737 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 16:49:40,738 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 16:49:40,739 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 16:49:40,741 - jwst.combine_1d.combine1d - WARNING - 2 output pixel numbers were NaN
2025-09-13 16:49:40,742 - jwst.combine_1d.combine1d - WARNING - 51 elements of output had no corresponding input data;
2025-09-13 16:49:40,742 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 16:49:40,790 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 16:49:41,923 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faec20295b0>,).
2025-09-13 16:49:41,924 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 16:49:43,016 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faec20295b0>,).
2025-09-13 16:49:43,020 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 16:49:43,049 - jwst.extract_1d.extract - INFO - Working on slit 289
2025-09-13 16:49:43,051 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:49:43,052 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 48.00 (inclusive)
2025-09-13 16:49:43,106 - jwst.extract_1d.extract - INFO - Working on slit 289
2025-09-13 16:49:43,107 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:49:43,108 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 48.00 (inclusive)
2025-09-13 16:49:43,162 - jwst.extract_1d.extract - INFO - Working on slit 289
2025-09-13 16:49:43,163 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:49:43,164 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 48.00 (inclusive)
2025-09-13 16:49:43,311 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 16:49:44,417 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_03101_00001_nis_cal.fits>,).
2025-09-13 16:49:44,486 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 16:49:44,503 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 16:49:44,504 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 16:49:44,506 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 16:49:44,507 - jwst.combine_1d.combine1d - WARNING - 2 output pixel numbers were NaN
2025-09-13 16:49:44,507 - jwst.combine_1d.combine1d - WARNING - 35 elements of output had no corresponding input data;
2025-09-13 16:49:44,508 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 16:49:44,555 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 16:49:45,695 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faec20299a0>,).
2025-09-13 16:49:45,696 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 16:49:46,802 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faec20299a0>,).
2025-09-13 16:49:46,806 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 16:49:46,836 - jwst.extract_1d.extract - INFO - Working on slit 934
2025-09-13 16:49:46,837 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:49:46,838 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 49.00 (inclusive)
2025-09-13 16:49:46,892 - jwst.extract_1d.extract - INFO - Working on slit 934
2025-09-13 16:49:46,893 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:49:46,894 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 49.00 (inclusive)
2025-09-13 16:49:46,947 - jwst.extract_1d.extract - INFO - Working on slit 934
2025-09-13 16:49:46,949 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:49:46,949 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 50.00 (inclusive)
2025-09-13 16:49:47,096 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 16:49:48,246 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_03101_00001_nis_cal.fits>,).
2025-09-13 16:49:48,316 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 16:49:48,335 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 16:49:48,336 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 16:49:48,338 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 16:49:48,339 - jwst.combine_1d.combine1d - WARNING - 2 output pixel numbers were NaN
2025-09-13 16:49:48,339 - jwst.combine_1d.combine1d - WARNING - 49 elements of output had no corresponding input data;
2025-09-13 16:49:48,340 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 16:49:48,388 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 16:49:49,552 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faec2029d90>,).
2025-09-13 16:49:49,553 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 16:49:50,685 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faec2029d90>,).
2025-09-13 16:49:50,688 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 16:49:50,718 - jwst.extract_1d.extract - INFO - Working on slit 1219
2025-09-13 16:49:50,719 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:49:50,720 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 45.00 (inclusive)
2025-09-13 16:49:50,775 - jwst.extract_1d.extract - INFO - Working on slit 1219
2025-09-13 16:49:50,776 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:49:50,777 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 44.00 (inclusive)
2025-09-13 16:49:50,830 - jwst.extract_1d.extract - INFO - Working on slit 1219
2025-09-13 16:49:50,832 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:49:50,833 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 45.00 (inclusive)
2025-09-13 16:49:50,979 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 16:49:52,094 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_03101_00001_nis_cal.fits>,).
2025-09-13 16:49:52,162 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 16:49:52,180 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 16:49:52,182 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 16:49:52,183 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 16:49:52,185 - jwst.combine_1d.combine1d - WARNING - 3 output pixel numbers were NaN
2025-09-13 16:49:52,185 - jwst.combine_1d.combine1d - WARNING - 60 elements of output had no corresponding input data;
2025-09-13 16:49:52,186 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 16:49:52,233 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 16:49:53,325 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faec202a180>,).
2025-09-13 16:49:53,326 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 16:49:54,415 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faec202a180>,).
2025-09-13 16:49:54,419 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 16:49:54,450 - jwst.extract_1d.extract - INFO - Working on slit 927
2025-09-13 16:49:54,451 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:49:54,452 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 52.00 (inclusive)
2025-09-13 16:49:54,504 - jwst.extract_1d.extract - INFO - Working on slit 927
2025-09-13 16:49:54,505 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:49:54,506 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 51.00 (inclusive)
2025-09-13 16:49:54,558 - jwst.extract_1d.extract - INFO - Working on slit 927
2025-09-13 16:49:54,560 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:49:54,560 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 52.00 (inclusive)
2025-09-13 16:49:54,708 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 16:49:55,837 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_03101_00001_nis_cal.fits>,).
2025-09-13 16:49:55,906 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 16:49:55,924 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 16:49:55,926 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 16:49:55,927 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 16:49:55,928 - jwst.combine_1d.combine1d - WARNING - 3 output pixel numbers were NaN
2025-09-13 16:49:55,929 - jwst.combine_1d.combine1d - WARNING - 45 elements of output had no corresponding input data;
2025-09-13 16:49:55,929 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 16:49:55,976 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 16:49:57,090 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faec202a570>,).
2025-09-13 16:49:57,090 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 16:49:58,189 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faec202a570>,).
2025-09-13 16:49:58,193 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 16:49:58,222 - jwst.extract_1d.extract - INFO - Working on slit 1417
2025-09-13 16:49:58,223 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:49:58,224 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 39.00 (inclusive)
2025-09-13 16:49:58,277 - jwst.extract_1d.extract - INFO - Working on slit 1417
2025-09-13 16:49:58,278 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:49:58,279 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 39.00 (inclusive)
2025-09-13 16:49:58,331 - jwst.extract_1d.extract - INFO - Working on slit 1417
2025-09-13 16:49:58,332 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:49:58,333 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 38.00 (inclusive)
2025-09-13 16:49:58,477 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 16:49:59,573 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_03101_00001_nis_cal.fits>,).
2025-09-13 16:49:59,642 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 16:49:59,660 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 16:49:59,661 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 16:49:59,662 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 16:49:59,664 - jwst.combine_1d.combine1d - WARNING - 3 output pixel numbers were NaN
2025-09-13 16:49:59,664 - jwst.combine_1d.combine1d - WARNING - 38 elements of output had no corresponding input data;
2025-09-13 16:49:59,664 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 16:49:59,712 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 16:50:00,806 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faec202a960>,).
2025-09-13 16:50:00,806 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 16:50:01,929 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faec202a960>,).
2025-09-13 16:50:01,932 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 16:50:01,962 - jwst.extract_1d.extract - INFO - Working on slit 567
2025-09-13 16:50:01,963 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:50:01,964 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 45.00 (inclusive)
2025-09-13 16:50:02,018 - jwst.extract_1d.extract - INFO - Working on slit 567
2025-09-13 16:50:02,019 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:50:02,020 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 45.00 (inclusive)
2025-09-13 16:50:02,073 - jwst.extract_1d.extract - INFO - Working on slit 567
2025-09-13 16:50:02,074 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:50:02,075 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 45.00 (inclusive)
2025-09-13 16:50:02,222 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 16:50:03,339 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_03101_00001_nis_cal.fits>,).
2025-09-13 16:50:03,407 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 16:50:03,425 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 16:50:03,427 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 16:50:03,428 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 16:50:03,429 - jwst.combine_1d.combine1d - WARNING - 3 output pixel numbers were NaN
2025-09-13 16:50:03,430 - jwst.combine_1d.combine1d - WARNING - 49 elements of output had no corresponding input data;
2025-09-13 16:50:03,430 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 16:50:03,477 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 16:50:04,536 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faec202ad50>,).
2025-09-13 16:50:04,537 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 16:50:05,634 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faec202ad50>,).
2025-09-13 16:50:05,638 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 16:50:05,667 - jwst.extract_1d.extract - INFO - Working on slit 1296
2025-09-13 16:50:05,668 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:50:05,669 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 41.00 (inclusive)
2025-09-13 16:50:05,721 - jwst.extract_1d.extract - INFO - Working on slit 1296
2025-09-13 16:50:05,722 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:50:05,723 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 42.00 (inclusive)
2025-09-13 16:50:05,774 - jwst.extract_1d.extract - INFO - Working on slit 1296
2025-09-13 16:50:05,775 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:50:05,776 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 41.00 (inclusive)
2025-09-13 16:50:05,916 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 16:50:06,996 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_03101_00001_nis_cal.fits>,).
2025-09-13 16:50:07,066 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 16:50:07,084 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 16:50:07,086 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 16:50:07,087 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 16:50:07,088 - jwst.combine_1d.combine1d - WARNING - 2 output pixel numbers were NaN
2025-09-13 16:50:07,089 - jwst.combine_1d.combine1d - WARNING - 44 elements of output had no corresponding input data;
2025-09-13 16:50:07,089 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 16:50:07,138 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 16:50:08,247 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faec202b140>,).
2025-09-13 16:50:08,248 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 16:50:09,367 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faec202b140>,).
2025-09-13 16:50:09,371 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 16:50:09,401 - jwst.extract_1d.extract - INFO - Working on slit 1412
2025-09-13 16:50:09,402 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:50:09,403 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 38.00 (inclusive)
2025-09-13 16:50:09,457 - jwst.extract_1d.extract - INFO - Working on slit 1412
2025-09-13 16:50:09,459 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:50:09,459 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 39.00 (inclusive)
2025-09-13 16:50:09,514 - jwst.extract_1d.extract - INFO - Working on slit 1412
2025-09-13 16:50:09,515 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:50:09,516 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 39.00 (inclusive)
2025-09-13 16:50:09,661 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 16:50:10,777 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_03101_00001_nis_cal.fits>,).
2025-09-13 16:50:10,846 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 16:50:10,865 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 16:50:10,866 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 16:50:10,867 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 16:50:10,869 - jwst.combine_1d.combine1d - WARNING - 3 output pixel numbers were NaN
2025-09-13 16:50:10,869 - jwst.combine_1d.combine1d - WARNING - 40 elements of output had no corresponding input data;
2025-09-13 16:50:10,870 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 16:50:10,917 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 16:50:11,950 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faec202b530>,).
2025-09-13 16:50:11,951 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 16:50:12,989 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faec202b530>,).
2025-09-13 16:50:12,993 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 16:50:13,023 - jwst.extract_1d.extract - INFO - Working on slit 654
2025-09-13 16:50:13,024 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:50:13,025 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 66.00 (inclusive)
2025-09-13 16:50:13,080 - jwst.extract_1d.extract - INFO - Working on slit 654
2025-09-13 16:50:13,081 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:50:13,082 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 65.00 (inclusive)
2025-09-13 16:50:13,136 - jwst.extract_1d.extract - INFO - Working on slit 654
2025-09-13 16:50:13,137 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:50:13,138 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 65.00 (inclusive)
2025-09-13 16:50:13,284 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 16:50:14,365 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_03101_00001_nis_cal.fits>,).
2025-09-13 16:50:14,433 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 16:50:14,452 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 16:50:14,454 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 16:50:14,455 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 16:50:14,456 - jwst.combine_1d.combine1d - WARNING - 2 output pixel numbers were NaN
2025-09-13 16:50:14,457 - jwst.combine_1d.combine1d - WARNING - 60 elements of output had no corresponding input data;
2025-09-13 16:50:14,457 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 16:50:14,505 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 16:50:15,578 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faec202b920>,).
2025-09-13 16:50:15,579 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 16:50:16,669 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faec202b920>,).
2025-09-13 16:50:16,672 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 16:50:16,702 - jwst.extract_1d.extract - INFO - Working on slit 1029
2025-09-13 16:50:16,703 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:50:16,704 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 73.00 (inclusive)
2025-09-13 16:50:16,758 - jwst.extract_1d.extract - INFO - Working on slit 1029
2025-09-13 16:50:16,759 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:50:16,760 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 74.00 (inclusive)
2025-09-13 16:50:16,813 - jwst.extract_1d.extract - INFO - Working on slit 1029
2025-09-13 16:50:16,814 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:50:16,815 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 73.00 (inclusive)
2025-09-13 16:50:16,961 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 16:50:18,089 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_03101_00001_nis_cal.fits>,).
2025-09-13 16:50:18,159 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 16:50:18,177 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 16:50:18,179 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 16:50:18,180 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 16:50:18,181 - jwst.combine_1d.combine1d - WARNING - 3 output pixel numbers were NaN
2025-09-13 16:50:18,182 - jwst.combine_1d.combine1d - WARNING - 57 elements of output had no corresponding input data;
2025-09-13 16:50:18,182 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 16:50:18,229 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 16:50:19,278 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faec202bd10>,).
2025-09-13 16:50:19,278 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 16:50:20,317 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faec202bd10>,).
2025-09-13 16:50:20,320 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 16:50:20,350 - jwst.extract_1d.extract - INFO - Working on slit 553
2025-09-13 16:50:20,351 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:50:20,352 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 48.00 (inclusive)
2025-09-13 16:50:20,405 - jwst.extract_1d.extract - INFO - Working on slit 553
2025-09-13 16:50:20,406 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:50:20,407 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 47.00 (inclusive)
2025-09-13 16:50:20,458 - jwst.extract_1d.extract - INFO - Working on slit 553
2025-09-13 16:50:20,459 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:50:20,459 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 47.00 (inclusive)
2025-09-13 16:50:20,602 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 16:50:21,637 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_03101_00001_nis_cal.fits>,).
2025-09-13 16:50:21,706 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 16:50:21,724 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 16:50:21,725 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 16:50:21,726 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 16:50:21,727 - jwst.combine_1d.combine1d - WARNING - 2 output pixel numbers were NaN
2025-09-13 16:50:21,728 - jwst.combine_1d.combine1d - WARNING - 35 elements of output had no corresponding input data;
2025-09-13 16:50:21,728 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 16:50:21,776 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 16:50:22,806 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faec20289e0>,).
2025-09-13 16:50:22,807 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 16:50:23,867 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faec20289e0>,).
2025-09-13 16:50:23,871 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 16:50:23,901 - jwst.extract_1d.extract - INFO - Working on slit 1387
2025-09-13 16:50:23,902 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:50:23,903 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 38.00 (inclusive)
2025-09-13 16:50:23,958 - jwst.extract_1d.extract - INFO - Working on slit 1387
2025-09-13 16:50:23,959 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:50:23,960 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 38.00 (inclusive)
2025-09-13 16:50:24,013 - jwst.extract_1d.extract - INFO - Working on slit 1387
2025-09-13 16:50:24,014 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:50:24,015 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 38.00 (inclusive)
2025-09-13 16:50:24,162 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 16:50:25,244 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_03101_00001_nis_cal.fits>,).
2025-09-13 16:50:25,315 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 16:50:25,332 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 16:50:25,334 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 16:50:25,335 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 16:50:25,336 - jwst.combine_1d.combine1d - WARNING - 2 output pixel numbers were NaN
2025-09-13 16:50:25,336 - jwst.combine_1d.combine1d - WARNING - 41 elements of output had no corresponding input data;
2025-09-13 16:50:25,337 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 16:50:25,384 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 16:50:26,415 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faeb5858560>,).
2025-09-13 16:50:26,415 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 16:50:27,436 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faeb5858560>,).
2025-09-13 16:50:27,439 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 16:50:27,469 - jwst.extract_1d.extract - INFO - Working on slit 422
2025-09-13 16:50:27,470 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:50:27,470 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 32.00 (inclusive)
2025-09-13 16:50:27,523 - jwst.extract_1d.extract - INFO - Working on slit 422
2025-09-13 16:50:27,524 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:50:27,525 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 32.00 (inclusive)
2025-09-13 16:50:27,577 - jwst.extract_1d.extract - INFO - Working on slit 422
2025-09-13 16:50:27,579 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:50:27,579 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 31.00 (inclusive)
2025-09-13 16:50:27,722 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 16:50:28,728 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_03101_00001_nis_cal.fits>,).
2025-09-13 16:50:28,795 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 16:50:28,811 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 16:50:28,812 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 16:50:28,814 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 16:50:28,815 - jwst.combine_1d.combine1d - WARNING - 2 output pixel numbers were NaN
2025-09-13 16:50:28,815 - jwst.combine_1d.combine1d - WARNING - 29 elements of output had no corresponding input data;
2025-09-13 16:50:28,816 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 16:50:28,861 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 16:50:29,859 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faeb5858950>,).
2025-09-13 16:50:29,859 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 16:50:30,900 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faeb5858950>,).
2025-09-13 16:50:30,903 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 16:50:30,933 - jwst.extract_1d.extract - INFO - Working on slit 821
2025-09-13 16:50:30,934 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:50:30,935 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 36.00 (inclusive)
2025-09-13 16:50:30,989 - jwst.extract_1d.extract - INFO - Working on slit 821
2025-09-13 16:50:30,990 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:50:30,991 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 37.00 (inclusive)
2025-09-13 16:50:31,045 - jwst.extract_1d.extract - INFO - Working on slit 821
2025-09-13 16:50:31,046 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:50:31,047 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 36.00 (inclusive)
2025-09-13 16:50:31,195 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 16:50:32,235 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_03101_00001_nis_cal.fits>,).
2025-09-13 16:50:32,305 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 16:50:32,323 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 16:50:32,325 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 16:50:32,326 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 16:50:32,327 - jwst.combine_1d.combine1d - WARNING - 3 output pixel numbers were NaN
2025-09-13 16:50:32,328 - jwst.combine_1d.combine1d - WARNING - 44 elements of output had no corresponding input data;
2025-09-13 16:50:32,328 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 16:50:32,378 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 16:50:33,438 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faeb5858d40>,).
2025-09-13 16:50:33,439 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 16:50:34,519 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faeb5858d40>,).
2025-09-13 16:50:34,523 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 16:50:34,554 - jwst.extract_1d.extract - INFO - Working on slit 682
2025-09-13 16:50:34,555 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:50:34,556 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 41.00 (inclusive)
2025-09-13 16:50:34,611 - jwst.extract_1d.extract - INFO - Working on slit 682
2025-09-13 16:50:34,613 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:50:34,614 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 42.00 (inclusive)
2025-09-13 16:50:34,668 - jwst.extract_1d.extract - INFO - Working on slit 682
2025-09-13 16:50:34,669 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:50:34,670 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 41.00 (inclusive)
2025-09-13 16:50:34,821 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 16:50:35,855 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_03101_00001_nis_cal.fits>,).
2025-09-13 16:50:35,924 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 16:50:35,942 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 16:50:35,943 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 16:50:35,944 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 16:50:35,946 - jwst.combine_1d.combine1d - WARNING - 3 output pixel numbers were NaN
2025-09-13 16:50:35,947 - jwst.combine_1d.combine1d - WARNING - 52 elements of output had no corresponding input data;
2025-09-13 16:50:35,947 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 16:50:35,995 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 16:50:37,028 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faeb5859130>,).
2025-09-13 16:50:37,028 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 16:50:38,093 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faeb5859130>,).
2025-09-13 16:50:38,096 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 16:50:38,128 - jwst.extract_1d.extract - INFO - Working on slit 1140
2025-09-13 16:50:38,129 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:50:38,129 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 48.00 (inclusive)
2025-09-13 16:50:38,183 - jwst.extract_1d.extract - INFO - Working on slit 1140
2025-09-13 16:50:38,184 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:50:38,185 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 47.00 (inclusive)
2025-09-13 16:50:38,237 - jwst.extract_1d.extract - INFO - Working on slit 1140
2025-09-13 16:50:38,238 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:50:38,239 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 48.00 (inclusive)
2025-09-13 16:50:38,385 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 16:50:39,446 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_03101_00001_nis_cal.fits>,).
2025-09-13 16:50:39,517 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 16:50:39,535 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 16:50:39,537 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 16:50:39,538 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 16:50:39,539 - jwst.combine_1d.combine1d - WARNING - 2 output pixel numbers were NaN
2025-09-13 16:50:39,540 - jwst.combine_1d.combine1d - WARNING - 42 elements of output had no corresponding input data;
2025-09-13 16:50:39,540 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 16:50:39,589 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 16:50:40,645 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faeb5859520>,).
2025-09-13 16:50:40,646 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 16:50:41,691 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faeb5859520>,).
2025-09-13 16:50:41,694 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 16:50:41,725 - jwst.extract_1d.extract - INFO - Working on slit 1388
2025-09-13 16:50:41,726 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:50:41,727 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 51.00 (inclusive)
2025-09-13 16:50:41,781 - jwst.extract_1d.extract - INFO - Working on slit 1388
2025-09-13 16:50:41,782 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:50:41,783 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 50.00 (inclusive)
2025-09-13 16:50:41,837 - jwst.extract_1d.extract - INFO - Working on slit 1388
2025-09-13 16:50:41,838 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:50:41,839 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 51.00 (inclusive)
2025-09-13 16:50:41,988 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 16:50:43,001 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_03101_00001_nis_cal.fits>,).
2025-09-13 16:50:43,070 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 16:50:43,089 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 16:50:43,090 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 16:50:43,091 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 16:50:43,093 - jwst.combine_1d.combine1d - WARNING - 2 output pixel numbers were NaN
2025-09-13 16:50:43,093 - jwst.combine_1d.combine1d - WARNING - 59 elements of output had no corresponding input data;
2025-09-13 16:50:43,094 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 16:50:43,140 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 16:50:44,186 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faeb5859910>,).
2025-09-13 16:50:44,187 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 16:50:45,295 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faeb5859910>,).
2025-09-13 16:50:45,298 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 16:50:45,330 - jwst.extract_1d.extract - INFO - Working on slit 759
2025-09-13 16:50:45,331 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:50:45,332 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 45.00 (inclusive)
2025-09-13 16:50:45,388 - jwst.extract_1d.extract - INFO - Working on slit 759
2025-09-13 16:50:45,389 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:50:45,390 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 44.00 (inclusive)
2025-09-13 16:50:45,445 - jwst.extract_1d.extract - INFO - Working on slit 759
2025-09-13 16:50:45,446 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:50:45,447 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 45.00 (inclusive)
2025-09-13 16:50:45,596 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 16:50:46,701 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_03101_00001_nis_cal.fits>,).
2025-09-13 16:50:46,771 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 16:50:46,789 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 16:50:46,791 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 16:50:46,792 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 16:50:46,793 - jwst.combine_1d.combine1d - WARNING - 3 output pixel numbers were NaN
2025-09-13 16:50:46,794 - jwst.combine_1d.combine1d - WARNING - 41 elements of output had no corresponding input data;
2025-09-13 16:50:46,794 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 16:50:46,845 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 16:50:47,927 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faeb5859d00>,).
2025-09-13 16:50:47,928 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 16:50:48,970 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faeb5859d00>,).
2025-09-13 16:50:48,973 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 16:50:49,004 - jwst.extract_1d.extract - INFO - Working on slit 1407
2025-09-13 16:50:49,005 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:50:49,006 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 41.00 (inclusive)
2025-09-13 16:50:49,060 - jwst.extract_1d.extract - INFO - Working on slit 1407
2025-09-13 16:50:49,061 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:50:49,062 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 41.00 (inclusive)
2025-09-13 16:50:49,116 - jwst.extract_1d.extract - INFO - Working on slit 1407
2025-09-13 16:50:49,117 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:50:49,118 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 41.00 (inclusive)
2025-09-13 16:50:49,264 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 16:50:50,321 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_03101_00001_nis_cal.fits>,).
2025-09-13 16:50:50,393 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 16:50:50,411 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 16:50:50,412 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 16:50:50,414 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 16:50:50,415 - jwst.combine_1d.combine1d - WARNING - 3 output pixel numbers were NaN
2025-09-13 16:50:50,416 - jwst.combine_1d.combine1d - WARNING - 36 elements of output had no corresponding input data;
2025-09-13 16:50:50,416 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 16:50:50,466 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 16:50:51,531 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faeb585a0f0>,).
2025-09-13 16:50:51,532 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 16:50:52,631 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faeb585a0f0>,).
2025-09-13 16:50:52,635 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 16:50:52,666 - jwst.extract_1d.extract - INFO - Working on slit 1194
2025-09-13 16:50:52,667 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:50:52,668 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 42.00 (inclusive)
2025-09-13 16:50:52,723 - jwst.extract_1d.extract - INFO - Working on slit 1194
2025-09-13 16:50:52,724 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:50:52,725 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 41.00 (inclusive)
2025-09-13 16:50:52,780 - jwst.extract_1d.extract - INFO - Working on slit 1194
2025-09-13 16:50:52,781 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:50:52,782 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 41.00 (inclusive)
2025-09-13 16:50:52,931 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 16:50:54,047 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_03101_00001_nis_cal.fits>,).
2025-09-13 16:50:54,118 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 16:50:54,135 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 16:50:54,137 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 16:50:54,138 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 16:50:54,139 - jwst.combine_1d.combine1d - WARNING - 2 output pixel numbers were NaN
2025-09-13 16:50:54,140 - jwst.combine_1d.combine1d - WARNING - 29 elements of output had no corresponding input data;
2025-09-13 16:50:54,141 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 16:50:54,188 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 16:50:55,216 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faeb585a4e0>,).
2025-09-13 16:50:55,217 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 16:50:56,290 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faeb585a4e0>,).
2025-09-13 16:50:56,294 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 16:50:56,324 - jwst.extract_1d.extract - INFO - Working on slit 712
2025-09-13 16:50:56,325 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:50:56,326 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 41.00 (inclusive)
2025-09-13 16:50:56,381 - jwst.extract_1d.extract - INFO - Working on slit 712
2025-09-13 16:50:56,382 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:50:56,383 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 41.00 (inclusive)
2025-09-13 16:50:56,437 - jwst.extract_1d.extract - INFO - Working on slit 712
2025-09-13 16:50:56,438 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:50:56,439 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 40.00 (inclusive)
2025-09-13 16:50:56,586 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 16:50:57,679 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_03101_00001_nis_cal.fits>,).
2025-09-13 16:50:57,751 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 16:50:57,770 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 16:50:57,771 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 16:50:57,772 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 16:50:57,773 - jwst.combine_1d.combine1d - WARNING - 2 output pixel numbers were NaN
2025-09-13 16:50:57,774 - jwst.combine_1d.combine1d - WARNING - 36 elements of output had no corresponding input data;
2025-09-13 16:50:57,774 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 16:50:57,825 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 16:50:58,891 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faeb585a8d0>,).
2025-09-13 16:50:58,892 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 16:50:59,946 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faeb585a8d0>,).
2025-09-13 16:50:59,950 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 16:50:59,980 - jwst.extract_1d.extract - INFO - Working on slit 539
2025-09-13 16:50:59,981 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:50:59,982 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 28.00 (inclusive)
2025-09-13 16:51:00,037 - jwst.extract_1d.extract - INFO - Working on slit 539
2025-09-13 16:51:00,038 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:51:00,039 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 28.00 (inclusive)
2025-09-13 16:51:00,092 - jwst.extract_1d.extract - INFO - Working on slit 539
2025-09-13 16:51:00,093 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:51:00,094 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 27.00 (inclusive)
2025-09-13 16:51:00,239 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 16:51:01,294 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_03101_00001_nis_cal.fits>,).
2025-09-13 16:51:01,370 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 16:51:01,390 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 16:51:01,392 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 16:51:01,393 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 16:51:01,394 - jwst.combine_1d.combine1d - WARNING - 3 output pixel numbers were NaN
2025-09-13 16:51:01,395 - jwst.combine_1d.combine1d - WARNING - 44 elements of output had no corresponding input data;
2025-09-13 16:51:01,395 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 16:51:01,445 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 16:51:02,519 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faeb585acc0>,).
2025-09-13 16:51:02,520 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 16:51:03,573 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faeb585acc0>,).
2025-09-13 16:51:03,577 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 16:51:03,608 - jwst.extract_1d.extract - INFO - Working on slit 1008
2025-09-13 16:51:03,610 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:51:03,611 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 32.00 (inclusive)
2025-09-13 16:51:03,666 - jwst.extract_1d.extract - INFO - Working on slit 1008
2025-09-13 16:51:03,667 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:51:03,668 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 32.00 (inclusive)
2025-09-13 16:51:03,722 - jwst.extract_1d.extract - INFO - Working on slit 1008
2025-09-13 16:51:03,724 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:51:03,725 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 31.00 (inclusive)
2025-09-13 16:51:03,869 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 16:51:04,913 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_03101_00001_nis_cal.fits>,).
2025-09-13 16:51:04,982 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 16:51:04,999 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 16:51:05,000 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 16:51:05,001 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 16:51:05,002 - jwst.combine_1d.combine1d - WARNING - 3 output pixel numbers were NaN
2025-09-13 16:51:05,003 - jwst.combine_1d.combine1d - WARNING - 32 elements of output had no corresponding input data;
2025-09-13 16:51:05,003 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 16:51:05,052 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 16:51:06,125 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faeb585b0b0>,).
2025-09-13 16:51:06,126 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 16:51:07,259 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faeb585b0b0>,).
2025-09-13 16:51:07,263 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 16:51:07,294 - jwst.extract_1d.extract - INFO - Working on slit 347
2025-09-13 16:51:07,295 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type POINT
2025-09-13 16:51:07,296 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 10.00 (inclusive)
2025-09-13 16:51:07,303 - jwst.extract_1d.extract - INFO - Creating aperture correction.
2025-09-13 16:51:07,430 - jwst.extract_1d.extract - INFO - Working on slit 347
2025-09-13 16:51:07,431 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type POINT
2025-09-13 16:51:07,432 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 10.00 (inclusive)
2025-09-13 16:51:07,439 - jwst.extract_1d.extract - INFO - Creating aperture correction.
2025-09-13 16:51:07,567 - jwst.extract_1d.extract - INFO - Working on slit 347
2025-09-13 16:51:07,569 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type POINT
2025-09-13 16:51:07,570 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 10.00 (inclusive)
2025-09-13 16:51:07,577 - jwst.extract_1d.extract - INFO - Creating aperture correction.
2025-09-13 16:51:07,803 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 16:51:08,939 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_03101_00001_nis_cal.fits>,).
2025-09-13 16:51:09,008 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 16:51:09,025 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 16:51:09,027 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 16:51:09,028 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 16:51:09,030 - jwst.combine_1d.combine1d - WARNING - 2 output pixel numbers were NaN
2025-09-13 16:51:09,030 - jwst.combine_1d.combine1d - WARNING - 36 elements of output had no corresponding input data;
2025-09-13 16:51:09,031 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 16:51:09,078 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 16:51:10,189 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faeb585b4a0>,).
2025-09-13 16:51:10,190 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 16:51:11,300 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faeb585b4a0>,).
2025-09-13 16:51:11,304 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 16:51:11,334 - jwst.extract_1d.extract - INFO - Working on slit 276
2025-09-13 16:51:11,336 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:51:11,336 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 42.00 (inclusive)
2025-09-13 16:51:11,390 - jwst.extract_1d.extract - INFO - Working on slit 276
2025-09-13 16:51:11,391 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:51:11,392 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 43.00 (inclusive)
2025-09-13 16:51:11,445 - jwst.extract_1d.extract - INFO - Working on slit 276
2025-09-13 16:51:11,446 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:51:11,447 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 43.00 (inclusive)
2025-09-13 16:51:11,592 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 16:51:12,703 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_03101_00001_nis_cal.fits>,).
2025-09-13 16:51:12,773 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 16:51:12,793 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 16:51:12,795 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 16:51:12,796 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 16:51:12,797 - jwst.combine_1d.combine1d - WARNING - 2 output pixel numbers were NaN
2025-09-13 16:51:12,797 - jwst.combine_1d.combine1d - WARNING - 45 elements of output had no corresponding input data;
2025-09-13 16:51:12,798 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 16:51:12,845 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 16:51:13,963 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faee5969fd0>,).
2025-09-13 16:51:13,964 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 16:51:15,099 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faee5969fd0>,).
2025-09-13 16:51:15,103 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 16:51:15,133 - jwst.extract_1d.extract - INFO - Working on slit 605
2025-09-13 16:51:15,135 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type POINT
2025-09-13 16:51:15,135 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 10.00 (inclusive)
2025-09-13 16:51:15,142 - jwst.extract_1d.extract - INFO - Creating aperture correction.
2025-09-13 16:51:15,261 - jwst.extract_1d.extract - INFO - Working on slit 605
2025-09-13 16:51:15,262 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type POINT
2025-09-13 16:51:15,263 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 10.00 (inclusive)
2025-09-13 16:51:15,270 - jwst.extract_1d.extract - INFO - Creating aperture correction.
2025-09-13 16:51:15,389 - jwst.extract_1d.extract - INFO - Working on slit 605
2025-09-13 16:51:15,390 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type POINT
2025-09-13 16:51:15,391 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 10.00 (inclusive)
2025-09-13 16:51:15,398 - jwst.extract_1d.extract - INFO - Creating aperture correction.
2025-09-13 16:51:15,612 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 16:51:16,683 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_03101_00001_nis_cal.fits>,).
2025-09-13 16:51:16,753 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 16:51:16,770 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 16:51:16,771 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 16:51:16,772 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 16:51:16,774 - jwst.combine_1d.combine1d - WARNING - 2 output pixel numbers were NaN
2025-09-13 16:51:16,774 - jwst.combine_1d.combine1d - WARNING - 23 elements of output had no corresponding input data;
2025-09-13 16:51:16,775 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 16:51:16,822 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 16:51:17,891 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faeb585bbf0>,).
2025-09-13 16:51:17,892 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 16:51:18,971 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faeb585bbf0>,).
2025-09-13 16:51:18,974 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 16:51:19,004 - jwst.extract_1d.extract - INFO - Working on slit 922
2025-09-13 16:51:19,006 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:51:19,006 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 30.00 (inclusive)
2025-09-13 16:51:19,060 - jwst.extract_1d.extract - INFO - Working on slit 922
2025-09-13 16:51:19,061 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:51:19,063 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 31.00 (inclusive)
2025-09-13 16:51:19,115 - jwst.extract_1d.extract - INFO - Working on slit 922
2025-09-13 16:51:19,117 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:51:19,118 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 30.00 (inclusive)
2025-09-13 16:51:19,262 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 16:51:20,345 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_03101_00001_nis_cal.fits>,).
2025-09-13 16:51:20,414 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 16:51:20,431 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 16:51:20,433 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 16:51:20,434 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 16:51:20,435 - jwst.combine_1d.combine1d - WARNING - 3 output pixel numbers were NaN
2025-09-13 16:51:20,435 - jwst.combine_1d.combine1d - WARNING - 31 elements of output had no corresponding input data;
2025-09-13 16:51:20,436 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 16:51:20,484 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 16:51:21,600 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faeb585b890>,).
2025-09-13 16:51:21,601 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 16:51:22,728 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faeb585b890>,).
2025-09-13 16:51:22,732 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 16:51:22,762 - jwst.extract_1d.extract - INFO - Working on slit 736
2025-09-13 16:51:22,763 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:51:22,764 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 22.00 (inclusive)
2025-09-13 16:51:22,819 - jwst.extract_1d.extract - INFO - Working on slit 736
2025-09-13 16:51:22,820 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:51:22,821 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 19.00 (inclusive)
2025-09-13 16:51:22,875 - jwst.extract_1d.extract - INFO - Working on slit 736
2025-09-13 16:51:22,876 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:51:22,877 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 23.00 (inclusive)
2025-09-13 16:51:23,025 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 16:51:24,152 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_03101_00001_nis_cal.fits>,).
2025-09-13 16:51:24,221 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 16:51:24,238 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 16:51:24,239 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 16:51:24,240 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 16:51:24,241 - jwst.combine_1d.combine1d - WARNING - 2 output pixel numbers were NaN
2025-09-13 16:51:24,242 - jwst.combine_1d.combine1d - WARNING - 23 elements of output had no corresponding input data;
2025-09-13 16:51:24,242 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 16:51:24,289 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 16:51:25,370 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faeb5068440>,).
2025-09-13 16:51:25,371 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 16:51:26,428 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faeb5068440>,).
2025-09-13 16:51:26,431 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 16:51:26,460 - jwst.extract_1d.extract - INFO - Working on slit 1423
2025-09-13 16:51:26,461 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:51:26,462 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 32.00 (inclusive)
2025-09-13 16:51:26,515 - jwst.extract_1d.extract - INFO - Working on slit 1423
2025-09-13 16:51:26,516 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:51:26,517 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 33.00 (inclusive)
2025-09-13 16:51:26,570 - jwst.extract_1d.extract - INFO - Working on slit 1423
2025-09-13 16:51:26,572 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:51:26,572 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 32.00 (inclusive)
2025-09-13 16:51:26,717 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 16:51:27,792 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_03101_00001_nis_cal.fits>,).
2025-09-13 16:51:27,862 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 16:51:27,880 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 16:51:27,881 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 16:51:27,883 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 16:51:27,884 - jwst.combine_1d.combine1d - WARNING - 2 output pixel numbers were NaN
2025-09-13 16:51:27,884 - jwst.combine_1d.combine1d - WARNING - 33 elements of output had no corresponding input data;
2025-09-13 16:51:27,884 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 16:51:27,932 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 16:51:29,084 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faeb5068830>,).
2025-09-13 16:51:29,085 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 16:51:30,161 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faeb5068830>,).
2025-09-13 16:51:30,164 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 16:51:30,196 - jwst.extract_1d.extract - INFO - Working on slit 800
2025-09-13 16:51:30,197 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:51:30,198 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 28.00 (inclusive)
2025-09-13 16:51:30,252 - jwst.extract_1d.extract - INFO - Working on slit 800
2025-09-13 16:51:30,253 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:51:30,254 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 27.00 (inclusive)
2025-09-13 16:51:30,308 - jwst.extract_1d.extract - INFO - Working on slit 800
2025-09-13 16:51:30,309 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:51:30,310 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 28.00 (inclusive)
2025-09-13 16:51:30,460 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 16:51:31,570 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_03101_00001_nis_cal.fits>,).
2025-09-13 16:51:31,640 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 16:51:31,658 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 16:51:31,659 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 16:51:31,661 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 16:51:31,662 - jwst.combine_1d.combine1d - WARNING - 3 output pixel numbers were NaN
2025-09-13 16:51:31,663 - jwst.combine_1d.combine1d - WARNING - 28 elements of output had no corresponding input data;
2025-09-13 16:51:31,663 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 16:51:31,712 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 16:51:32,831 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faeb5068c20>,).
2025-09-13 16:51:32,832 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 16:51:33,941 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faeb5068c20>,).
2025-09-13 16:51:33,944 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 16:51:33,975 - jwst.extract_1d.extract - INFO - Working on slit 873
2025-09-13 16:51:33,976 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:51:33,977 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 23.00 (inclusive)
2025-09-13 16:51:34,030 - jwst.extract_1d.extract - INFO - Working on slit 873
2025-09-13 16:51:34,032 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:51:34,033 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 23.00 (inclusive)
2025-09-13 16:51:34,086 - jwst.extract_1d.extract - INFO - Working on slit 873
2025-09-13 16:51:34,087 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:51:34,088 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 22.00 (inclusive)
2025-09-13 16:51:34,234 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 16:51:35,381 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_03101_00001_nis_cal.fits>,).
2025-09-13 16:51:35,450 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 16:51:35,468 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 16:51:35,470 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 16:51:35,471 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 16:51:35,472 - jwst.combine_1d.combine1d - WARNING - 2 output pixel numbers were NaN
2025-09-13 16:51:35,473 - jwst.combine_1d.combine1d - WARNING - 28 elements of output had no corresponding input data;
2025-09-13 16:51:35,473 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 16:51:35,521 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 16:51:36,677 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faeb5069010>,).
2025-09-13 16:51:36,678 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 16:51:37,828 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faeb5069010>,).
2025-09-13 16:51:37,832 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 16:51:37,861 - jwst.extract_1d.extract - INFO - Working on slit 385
2025-09-13 16:51:37,862 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:51:37,863 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 41.00 (inclusive)
2025-09-13 16:51:37,916 - jwst.extract_1d.extract - INFO - Working on slit 385
2025-09-13 16:51:37,917 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:51:37,918 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 41.00 (inclusive)
2025-09-13 16:51:37,970 - jwst.extract_1d.extract - INFO - Working on slit 385
2025-09-13 16:51:37,971 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:51:37,972 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 41.00 (inclusive)
2025-09-13 16:51:38,116 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 16:51:39,221 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_03101_00001_nis_cal.fits>,).
2025-09-13 16:51:39,291 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 16:51:39,308 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 16:51:39,310 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 16:51:39,311 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 16:51:39,312 - jwst.combine_1d.combine1d - WARNING - 3 output pixel numbers were NaN
2025-09-13 16:51:39,313 - jwst.combine_1d.combine1d - WARNING - 22 elements of output had no corresponding input data;
2025-09-13 16:51:39,313 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 16:51:39,362 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 16:51:40,485 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faeb5069400>,).
2025-09-13 16:51:40,486 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 16:51:41,580 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faeb5069400>,).
2025-09-13 16:51:41,583 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 16:51:41,613 - jwst.extract_1d.extract - INFO - Working on slit 557
2025-09-13 16:51:41,614 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:51:41,615 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 38.00 (inclusive)
2025-09-13 16:51:41,668 - jwst.extract_1d.extract - INFO - Working on slit 557
2025-09-13 16:51:41,669 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:51:41,670 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 38.00 (inclusive)
2025-09-13 16:51:41,722 - jwst.extract_1d.extract - INFO - Working on slit 557
2025-09-13 16:51:41,723 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:51:41,724 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 38.00 (inclusive)
2025-09-13 16:51:41,869 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 16:51:42,949 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_03101_00001_nis_cal.fits>,).
2025-09-13 16:51:43,020 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 16:51:43,038 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 16:51:43,040 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 16:51:43,041 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 16:51:43,042 - jwst.combine_1d.combine1d - WARNING - 3 output pixel numbers were NaN
2025-09-13 16:51:43,042 - jwst.combine_1d.combine1d - WARNING - 39 elements of output had no corresponding input data;
2025-09-13 16:51:43,043 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 16:51:43,092 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 16:51:44,206 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faeb50697f0>,).
2025-09-13 16:51:44,207 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 16:51:45,356 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faeb50697f0>,).
2025-09-13 16:51:45,360 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 16:51:45,389 - jwst.extract_1d.extract - INFO - Working on slit 719
2025-09-13 16:51:45,390 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:51:45,391 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 24.00 (inclusive)
2025-09-13 16:51:45,444 - jwst.extract_1d.extract - INFO - Working on slit 719
2025-09-13 16:51:45,445 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:51:45,446 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 24.00 (inclusive)
2025-09-13 16:51:45,499 - jwst.extract_1d.extract - INFO - Working on slit 719
2025-09-13 16:51:45,500 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:51:45,501 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 24.00 (inclusive)
2025-09-13 16:51:45,645 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 16:51:46,778 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_03101_00001_nis_cal.fits>,).
2025-09-13 16:51:46,848 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 16:51:46,865 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 16:51:46,866 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 16:51:46,867 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 16:51:46,869 - jwst.combine_1d.combine1d - WARNING - 2 output pixel numbers were NaN
2025-09-13 16:51:46,869 - jwst.combine_1d.combine1d - WARNING - 31 elements of output had no corresponding input data;
2025-09-13 16:51:46,870 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 16:51:46,917 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 16:51:48,035 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faeb5069be0>,).
2025-09-13 16:51:48,036 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 16:51:49,156 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faeb5069be0>,).
2025-09-13 16:51:49,159 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 16:51:49,189 - jwst.extract_1d.extract - INFO - Working on slit 389
2025-09-13 16:51:49,190 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:51:49,191 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 33.00 (inclusive)
2025-09-13 16:51:49,245 - jwst.extract_1d.extract - INFO - Working on slit 389
2025-09-13 16:51:49,246 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:51:49,247 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 32.00 (inclusive)
2025-09-13 16:51:49,300 - jwst.extract_1d.extract - INFO - Working on slit 389
2025-09-13 16:51:49,301 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:51:49,302 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 32.00 (inclusive)
2025-09-13 16:51:49,447 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 16:51:50,544 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_03101_00001_nis_cal.fits>,).
2025-09-13 16:51:50,614 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 16:51:50,632 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 16:51:50,633 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 16:51:50,635 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 16:51:50,636 - jwst.combine_1d.combine1d - WARNING - 2 output pixel numbers were NaN
2025-09-13 16:51:50,636 - jwst.combine_1d.combine1d - WARNING - 31 elements of output had no corresponding input data;
2025-09-13 16:51:50,637 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 16:51:50,686 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 16:51:51,776 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faeb5069fd0>,).
2025-09-13 16:51:51,777 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 16:51:52,841 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faeb5069fd0>,).
2025-09-13 16:51:52,844 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 16:51:52,874 - jwst.extract_1d.extract - INFO - Working on slit 733
2025-09-13 16:51:52,875 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:51:52,876 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 54.00 (inclusive)
2025-09-13 16:51:52,930 - jwst.extract_1d.extract - INFO - Working on slit 733
2025-09-13 16:51:52,931 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:51:52,932 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 53.00 (inclusive)
2025-09-13 16:51:52,984 - jwst.extract_1d.extract - INFO - Working on slit 733
2025-09-13 16:51:52,985 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:51:52,986 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 53.00 (inclusive)
2025-09-13 16:51:53,131 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 16:51:54,182 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_03101_00001_nis_cal.fits>,).
2025-09-13 16:51:54,251 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 16:51:54,268 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 16:51:54,270 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 16:51:54,271 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 16:51:54,272 - jwst.combine_1d.combine1d - WARNING - 3 output pixel numbers were NaN
2025-09-13 16:51:54,272 - jwst.combine_1d.combine1d - WARNING - 44 elements of output had no corresponding input data;
2025-09-13 16:51:54,273 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 16:51:54,319 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 16:51:55,364 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faeb506a3c0>,).
2025-09-13 16:51:55,365 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 16:51:56,415 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faeb506a3c0>,).
2025-09-13 16:51:56,418 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 16:51:56,448 - jwst.extract_1d.extract - INFO - Working on slit 1442
2025-09-13 16:51:56,449 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:51:56,450 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 43.00 (inclusive)
2025-09-13 16:51:56,503 - jwst.extract_1d.extract - INFO - Working on slit 1442
2025-09-13 16:51:56,504 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:51:56,505 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 44.00 (inclusive)
2025-09-13 16:51:56,557 - jwst.extract_1d.extract - INFO - Working on slit 1442
2025-09-13 16:51:56,559 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:51:56,559 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 43.00 (inclusive)
2025-09-13 16:51:56,703 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 16:51:57,794 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_03101_00001_nis_cal.fits>,).
2025-09-13 16:51:57,865 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 16:51:57,883 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 16:51:57,884 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 16:51:57,886 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 16:51:57,887 - jwst.combine_1d.combine1d - WARNING - 2 output pixel numbers were NaN
2025-09-13 16:51:57,888 - jwst.combine_1d.combine1d - WARNING - 45 elements of output had no corresponding input data;
2025-09-13 16:51:57,888 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 16:51:57,936 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 16:51:59,022 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faeb506a7b0>,).
2025-09-13 16:51:59,023 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 16:52:00,117 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faeb506a7b0>,).
2025-09-13 16:52:00,121 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 16:52:00,150 - jwst.extract_1d.extract - INFO - Working on slit 417
2025-09-13 16:52:00,151 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:52:00,152 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 25.00 (inclusive)
2025-09-13 16:52:00,205 - jwst.extract_1d.extract - INFO - Working on slit 417
2025-09-13 16:52:00,206 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:52:00,207 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 26.00 (inclusive)
2025-09-13 16:52:00,261 - jwst.extract_1d.extract - INFO - Working on slit 417
2025-09-13 16:52:00,262 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:52:00,263 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 25.00 (inclusive)
2025-09-13 16:52:00,408 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 16:52:01,488 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_03101_00001_nis_cal.fits>,).
2025-09-13 16:52:01,558 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 16:52:01,576 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 16:52:01,577 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 16:52:01,579 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 16:52:01,580 - jwst.combine_1d.combine1d - WARNING - 2 output pixel numbers were NaN
2025-09-13 16:52:01,580 - jwst.combine_1d.combine1d - WARNING - 29 elements of output had no corresponding input data;
2025-09-13 16:52:01,581 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 16:52:01,628 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 16:52:02,713 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faeb506aba0>,).
2025-09-13 16:52:02,713 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 16:52:03,784 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faeb506aba0>,).
2025-09-13 16:52:03,788 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 16:52:03,817 - jwst.extract_1d.extract - INFO - Working on slit 630
2025-09-13 16:52:03,819 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type POINT
2025-09-13 16:52:03,819 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 10.00 (inclusive)
2025-09-13 16:52:03,826 - jwst.extract_1d.extract - INFO - Creating aperture correction.
2025-09-13 16:52:03,941 - jwst.extract_1d.extract - INFO - Working on slit 630
2025-09-13 16:52:03,942 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type POINT
2025-09-13 16:52:03,943 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 10.00 (inclusive)
2025-09-13 16:52:03,950 - jwst.extract_1d.extract - INFO - Creating aperture correction.
2025-09-13 16:52:04,066 - jwst.extract_1d.extract - INFO - Working on slit 630
2025-09-13 16:52:04,067 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type POINT
2025-09-13 16:52:04,068 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 10.00 (inclusive)
2025-09-13 16:52:04,074 - jwst.extract_1d.extract - INFO - Creating aperture correction.
2025-09-13 16:52:04,283 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 16:52:05,372 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_03101_00001_nis_cal.fits>,).
2025-09-13 16:52:05,441 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 16:52:05,457 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 16:52:05,458 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 16:52:05,459 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 16:52:05,461 - jwst.combine_1d.combine1d - WARNING - 2 output pixel numbers were NaN
2025-09-13 16:52:05,461 - jwst.combine_1d.combine1d - WARNING - 17 elements of output had no corresponding input data;
2025-09-13 16:52:05,461 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 16:52:05,509 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 16:52:06,613 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faeb506af90>,).
2025-09-13 16:52:06,614 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 16:52:07,625 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faeb506af90>,).
2025-09-13 16:52:07,629 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 16:52:07,658 - jwst.extract_1d.extract - INFO - Working on slit 925
2025-09-13 16:52:07,659 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:52:07,660 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 43.00 (inclusive)
2025-09-13 16:52:07,712 - jwst.extract_1d.extract - INFO - Working on slit 925
2025-09-13 16:52:07,713 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:52:07,714 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 42.00 (inclusive)
2025-09-13 16:52:07,766 - jwst.extract_1d.extract - INFO - Working on slit 925
2025-09-13 16:52:07,767 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:52:07,768 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 42.00 (inclusive)
2025-09-13 16:52:07,908 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 16:52:08,933 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_03101_00001_nis_cal.fits>,).
2025-09-13 16:52:09,001 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 16:52:09,018 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 16:52:09,019 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 16:52:09,020 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 16:52:09,021 - jwst.combine_1d.combine1d - WARNING - 3 output pixel numbers were NaN
2025-09-13 16:52:09,022 - jwst.combine_1d.combine1d - WARNING - 34 elements of output had no corresponding input data;
2025-09-13 16:52:09,022 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 16:52:09,069 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 16:52:10,101 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faeb506b380>,).
2025-09-13 16:52:10,101 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 16:52:11,133 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faeb506b380>,).
2025-09-13 16:52:11,136 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 16:52:11,166 - jwst.extract_1d.extract - INFO - Working on slit 527
2025-09-13 16:52:11,167 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:52:11,168 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 28.00 (inclusive)
2025-09-13 16:52:11,221 - jwst.extract_1d.extract - INFO - Working on slit 527
2025-09-13 16:52:11,222 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:52:11,223 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 28.00 (inclusive)
2025-09-13 16:52:11,275 - jwst.extract_1d.extract - INFO - Working on slit 527
2025-09-13 16:52:11,276 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:52:11,277 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 28.00 (inclusive)
2025-09-13 16:52:11,420 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 16:52:12,495 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_03101_00001_nis_cal.fits>,).
2025-09-13 16:52:12,564 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 16:52:12,581 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 16:52:12,583 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 16:52:12,584 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 16:52:12,585 - jwst.combine_1d.combine1d - WARNING - 3 output pixel numbers were NaN
2025-09-13 16:52:12,586 - jwst.combine_1d.combine1d - WARNING - 37 elements of output had no corresponding input data;
2025-09-13 16:52:12,586 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 16:52:12,634 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 16:52:13,676 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faeb506b770>,).
2025-09-13 16:52:13,677 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 16:52:14,704 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faeb506b770>,).
2025-09-13 16:52:14,707 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 16:52:14,737 - jwst.extract_1d.extract - INFO - Working on slit 439
2025-09-13 16:52:14,738 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type POINT
2025-09-13 16:52:14,739 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 10.00 (inclusive)
2025-09-13 16:52:14,746 - jwst.extract_1d.extract - INFO - Creating aperture correction.
2025-09-13 16:52:14,867 - jwst.extract_1d.extract - INFO - Working on slit 439
2025-09-13 16:52:14,868 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type POINT
2025-09-13 16:52:14,869 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 10.00 (inclusive)
2025-09-13 16:52:14,876 - jwst.extract_1d.extract - INFO - Creating aperture correction.
2025-09-13 16:52:14,999 - jwst.extract_1d.extract - INFO - Working on slit 439
2025-09-13 16:52:15,000 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type POINT
2025-09-13 16:52:15,001 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 10.00 (inclusive)
2025-09-13 16:52:15,008 - jwst.extract_1d.extract - INFO - Creating aperture correction.
2025-09-13 16:52:15,220 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 16:52:16,222 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_03101_00001_nis_cal.fits>,).
2025-09-13 16:52:16,290 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 16:52:16,307 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 16:52:16,309 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 16:52:16,310 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 16:52:16,311 - jwst.combine_1d.combine1d - WARNING - 2 output pixel numbers were NaN
2025-09-13 16:52:16,312 - jwst.combine_1d.combine1d - WARNING - 34 elements of output had no corresponding input data;
2025-09-13 16:52:16,312 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 16:52:16,359 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 16:52:17,356 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faeb506bb60>,).
2025-09-13 16:52:17,357 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 16:52:18,350 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faeb506bb60>,).
2025-09-13 16:52:18,353 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 16:52:18,382 - jwst.extract_1d.extract - INFO - Working on slit 1253
2025-09-13 16:52:18,383 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:52:18,384 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 23.00 (inclusive)
2025-09-13 16:52:18,437 - jwst.extract_1d.extract - INFO - Working on slit 1253
2025-09-13 16:52:18,438 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:52:18,438 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 23.00 (inclusive)
2025-09-13 16:52:18,490 - jwst.extract_1d.extract - INFO - Working on slit 1253
2025-09-13 16:52:18,491 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:52:18,492 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 24.00 (inclusive)
2025-09-13 16:52:18,633 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 16:52:19,668 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_03101_00001_nis_cal.fits>,).
2025-09-13 16:52:19,735 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 16:52:19,752 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 16:52:19,753 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 16:52:19,754 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 16:52:19,755 - jwst.combine_1d.combine1d - WARNING - 3 output pixel numbers were NaN
2025-09-13 16:52:19,756 - jwst.combine_1d.combine1d - WARNING - 33 elements of output had no corresponding input data;
2025-09-13 16:52:19,756 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 16:52:19,803 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 16:52:20,825 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faeb506bf50>,).
2025-09-13 16:52:20,826 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 16:52:21,824 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faeb506bf50>,).
2025-09-13 16:52:21,827 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 16:52:21,857 - jwst.extract_1d.extract - INFO - Working on slit 1162
2025-09-13 16:52:21,858 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:52:21,859 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 21.00 (inclusive)
2025-09-13 16:52:21,911 - jwst.extract_1d.extract - INFO - Working on slit 1162
2025-09-13 16:52:21,912 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:52:21,913 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 20.00 (inclusive)
2025-09-13 16:52:21,964 - jwst.extract_1d.extract - INFO - Working on slit 1162
2025-09-13 16:52:21,965 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:52:21,966 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 21.00 (inclusive)
2025-09-13 16:52:22,106 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 16:52:23,108 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_03101_00001_nis_cal.fits>,).
2025-09-13 16:52:23,176 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 16:52:23,191 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 16:52:23,193 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 16:52:23,194 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 16:52:23,195 - jwst.combine_1d.combine1d - WARNING - 2 output pixel numbers were NaN
2025-09-13 16:52:23,195 - jwst.combine_1d.combine1d - WARNING - 19 elements of output had no corresponding input data;
2025-09-13 16:52:23,196 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 16:52:23,242 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 16:52:24,231 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faeb5068050>,).
2025-09-13 16:52:24,232 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 16:52:25,220 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faeb5068050>,).
2025-09-13 16:52:25,224 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 16:52:25,253 - jwst.extract_1d.extract - INFO - Working on slit 1457
2025-09-13 16:52:25,254 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:52:25,255 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 23.00 (inclusive)
2025-09-13 16:52:25,307 - jwst.extract_1d.extract - INFO - Working on slit 1457
2025-09-13 16:52:25,309 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:52:25,310 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 24.00 (inclusive)
2025-09-13 16:52:25,361 - jwst.extract_1d.extract - INFO - Working on slit 1457
2025-09-13 16:52:25,362 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:52:25,363 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 23.00 (inclusive)
2025-09-13 16:52:25,501 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 16:52:26,522 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_03101_00001_nis_cal.fits>,).
2025-09-13 16:52:26,592 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 16:52:26,610 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 16:52:26,611 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 16:52:26,612 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 16:52:26,613 - jwst.combine_1d.combine1d - WARNING - 2 output pixel numbers were NaN
2025-09-13 16:52:26,614 - jwst.combine_1d.combine1d - WARNING - 26 elements of output had no corresponding input data;
2025-09-13 16:52:26,614 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 16:52:26,662 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 16:52:27,730 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faeb48907a0>,).
2025-09-13 16:52:27,731 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 16:52:28,775 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faeb48907a0>,).
2025-09-13 16:52:28,778 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 16:52:28,808 - jwst.extract_1d.extract - INFO - Working on slit 694
2025-09-13 16:52:28,809 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:52:28,810 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 44.00 (inclusive)
2025-09-13 16:52:28,863 - jwst.extract_1d.extract - INFO - Working on slit 694
2025-09-13 16:52:28,865 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:52:28,865 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 44.00 (inclusive)
2025-09-13 16:52:28,918 - jwst.extract_1d.extract - INFO - Working on slit 694
2025-09-13 16:52:28,919 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:52:28,920 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 44.00 (inclusive)
2025-09-13 16:52:29,064 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 16:52:30,093 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_03101_00001_nis_cal.fits>,).
2025-09-13 16:52:30,162 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 16:52:30,179 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 16:52:30,181 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 16:52:30,182 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 16:52:30,183 - jwst.combine_1d.combine1d - WARNING - 3 output pixel numbers were NaN
2025-09-13 16:52:30,183 - jwst.combine_1d.combine1d - WARNING - 24 elements of output had no corresponding input data;
2025-09-13 16:52:30,184 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 16:52:30,232 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 16:52:31,278 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faeb4890b90>,).
2025-09-13 16:52:31,279 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 16:52:32,326 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faeb4890b90>,).
2025-09-13 16:52:32,330 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 16:52:32,360 - jwst.extract_1d.extract - INFO - Working on slit 1266
2025-09-13 16:52:32,361 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:52:32,362 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 36.00 (inclusive)
2025-09-13 16:52:32,415 - jwst.extract_1d.extract - INFO - Working on slit 1266
2025-09-13 16:52:32,416 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:52:32,417 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 36.00 (inclusive)
2025-09-13 16:52:32,469 - jwst.extract_1d.extract - INFO - Working on slit 1266
2025-09-13 16:52:32,470 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:52:32,471 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 37.00 (inclusive)
2025-09-13 16:52:32,619 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 16:52:33,698 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_03101_00001_nis_cal.fits>,).
2025-09-13 16:52:33,767 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 16:52:33,785 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 16:52:33,786 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 16:52:33,787 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 16:52:33,788 - jwst.combine_1d.combine1d - WARNING - 3 output pixel numbers were NaN
2025-09-13 16:52:33,789 - jwst.combine_1d.combine1d - WARNING - 27 elements of output had no corresponding input data;
2025-09-13 16:52:33,789 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 16:52:33,838 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 16:52:34,916 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faeb4890f80>,).
2025-09-13 16:52:34,917 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 16:52:35,976 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faeb4890f80>,).
2025-09-13 16:52:35,979 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 16:52:36,008 - jwst.extract_1d.extract - INFO - Working on slit 298
2025-09-13 16:52:36,009 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:52:36,010 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 33.00 (inclusive)
2025-09-13 16:52:36,062 - jwst.extract_1d.extract - INFO - Working on slit 298
2025-09-13 16:52:36,063 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:52:36,064 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 32.00 (inclusive)
2025-09-13 16:52:36,116 - jwst.extract_1d.extract - INFO - Working on slit 298
2025-09-13 16:52:36,117 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:52:36,118 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 32.00 (inclusive)
2025-09-13 16:52:36,260 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 16:52:37,296 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_03101_00001_nis_cal.fits>,).
2025-09-13 16:52:37,366 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 16:52:37,383 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 16:52:37,384 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 16:52:37,385 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 16:52:37,386 - jwst.combine_1d.combine1d - WARNING - 3 output pixel numbers were NaN
2025-09-13 16:52:37,387 - jwst.combine_1d.combine1d - WARNING - 23 elements of output had no corresponding input data;
2025-09-13 16:52:37,387 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 16:52:37,434 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 16:52:38,463 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faeb4891370>,).
2025-09-13 16:52:38,464 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 16:52:39,493 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faeb4891370>,).
2025-09-13 16:52:39,496 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 16:52:39,526 - jwst.extract_1d.extract - INFO - Working on slit 516
2025-09-13 16:52:39,527 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:52:39,528 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 30.00 (inclusive)
2025-09-13 16:52:39,580 - jwst.extract_1d.extract - INFO - Working on slit 516
2025-09-13 16:52:39,581 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:52:39,582 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 31.00 (inclusive)
2025-09-13 16:52:39,633 - jwst.extract_1d.extract - INFO - Working on slit 516
2025-09-13 16:52:39,634 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:52:39,635 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 30.00 (inclusive)
2025-09-13 16:52:39,775 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 16:52:40,807 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_03101_00001_nis_cal.fits>,).
2025-09-13 16:52:40,875 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 16:52:40,892 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 16:52:40,894 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 16:52:40,895 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 16:52:40,896 - jwst.combine_1d.combine1d - WARNING - 3 output pixel numbers were NaN
2025-09-13 16:52:40,896 - jwst.combine_1d.combine1d - WARNING - 35 elements of output had no corresponding input data;
2025-09-13 16:52:40,898 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 16:52:40,945 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 16:52:42,020 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faeb4891760>,).
2025-09-13 16:52:42,021 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 16:52:43,080 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faeb4891760>,).
2025-09-13 16:52:43,083 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 16:52:43,113 - jwst.extract_1d.extract - INFO - Working on slit 973
2025-09-13 16:52:43,114 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:52:43,115 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 22.00 (inclusive)
2025-09-13 16:52:43,169 - jwst.extract_1d.extract - INFO - Working on slit 973
2025-09-13 16:52:43,170 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:52:43,170 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 23.00 (inclusive)
2025-09-13 16:52:43,223 - jwst.extract_1d.extract - INFO - Working on slit 973
2025-09-13 16:52:43,224 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:52:43,225 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 22.00 (inclusive)
2025-09-13 16:52:43,367 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 16:52:44,391 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_03101_00001_nis_cal.fits>,).
2025-09-13 16:52:44,459 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 16:52:44,475 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 16:52:44,476 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 16:52:44,478 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 16:52:44,479 - jwst.combine_1d.combine1d - WARNING - 2 output pixel numbers were NaN
2025-09-13 16:52:44,479 - jwst.combine_1d.combine1d - WARNING - 23 elements of output had no corresponding input data;
2025-09-13 16:52:44,479 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 16:52:44,526 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 16:52:45,550 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faeb4891b50>,).
2025-09-13 16:52:45,551 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 16:52:46,562 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faeb4891b50>,).
2025-09-13 16:52:46,565 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 16:52:46,595 - jwst.extract_1d.extract - INFO - Working on slit 180
2025-09-13 16:52:46,596 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:52:46,597 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 43.00 (inclusive)
2025-09-13 16:52:46,649 - jwst.extract_1d.extract - INFO - Working on slit 180
2025-09-13 16:52:46,650 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:52:46,651 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 43.00 (inclusive)
2025-09-13 16:52:46,703 - jwst.extract_1d.extract - INFO - Working on slit 180
2025-09-13 16:52:46,704 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:52:46,705 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 42.00 (inclusive)
2025-09-13 16:52:46,847 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 16:52:47,890 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_03101_00001_nis_cal.fits>,).
2025-09-13 16:52:47,959 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 16:52:47,973 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 16:52:47,975 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 16:52:47,976 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 16:52:47,977 - jwst.combine_1d.combine1d - WARNING - 1 output pixel numbers were NaN
2025-09-13 16:52:47,977 - jwst.combine_1d.combine1d - WARNING - 22 elements of output had no corresponding input data;
2025-09-13 16:52:47,978 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 16:52:48,024 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 16:52:49,064 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faeb4891f40>,).
2025-09-13 16:52:49,065 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 16:52:50,118 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faeb4891f40>,).
2025-09-13 16:52:50,121 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 16:52:50,151 - jwst.extract_1d.extract - INFO - Working on slit 980
2025-09-13 16:52:50,152 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:52:50,153 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 39.00 (inclusive)
2025-09-13 16:52:50,208 - jwst.extract_1d.extract - INFO - Working on slit 980
2025-09-13 16:52:50,209 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:52:50,210 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 39.00 (inclusive)
2025-09-13 16:52:50,263 - jwst.extract_1d.extract - INFO - Working on slit 980
2025-09-13 16:52:50,264 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:52:50,265 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 40.00 (inclusive)
2025-09-13 16:52:50,409 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 16:52:51,424 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_03101_00001_nis_cal.fits>,).
2025-09-13 16:52:51,493 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 16:52:51,509 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 16:52:51,511 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 16:52:51,512 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 16:52:51,513 - jwst.combine_1d.combine1d - WARNING - 2 output pixel numbers were NaN
2025-09-13 16:52:51,513 - jwst.combine_1d.combine1d - WARNING - 31 elements of output had no corresponding input data;
2025-09-13 16:52:51,514 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 16:52:51,560 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 16:52:52,591 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faeb4892330>,).
2025-09-13 16:52:52,592 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 16:52:53,610 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faeb4892330>,).
2025-09-13 16:52:53,613 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 16:52:53,642 - jwst.extract_1d.extract - INFO - Working on slit 263
2025-09-13 16:52:53,643 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:52:53,644 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 38.00 (inclusive)
2025-09-13 16:52:53,696 - jwst.extract_1d.extract - INFO - Working on slit 263
2025-09-13 16:52:53,697 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:52:53,698 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 39.00 (inclusive)
2025-09-13 16:52:53,751 - jwst.extract_1d.extract - INFO - Working on slit 263
2025-09-13 16:52:53,752 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:52:53,753 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 38.00 (inclusive)
2025-09-13 16:52:53,893 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 16:52:54,905 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_03101_00001_nis_cal.fits>,).
2025-09-13 16:52:54,976 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 16:52:54,993 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 16:52:54,994 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 16:52:54,995 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 16:52:54,996 - jwst.combine_1d.combine1d - WARNING - 2 output pixel numbers were NaN
2025-09-13 16:52:54,997 - jwst.combine_1d.combine1d - WARNING - 26 elements of output had no corresponding input data;
2025-09-13 16:52:54,997 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 16:52:55,045 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 16:52:56,145 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faeb4892720>,).
2025-09-13 16:52:56,146 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 16:52:57,241 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faeb4892720>,).
2025-09-13 16:52:57,244 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 16:52:57,274 - jwst.extract_1d.extract - INFO - Working on slit 493
2025-09-13 16:52:57,275 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:52:57,276 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 30.00 (inclusive)
2025-09-13 16:52:57,329 - jwst.extract_1d.extract - INFO - Working on slit 493
2025-09-13 16:52:57,330 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:52:57,330 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 30.00 (inclusive)
2025-09-13 16:52:57,383 - jwst.extract_1d.extract - INFO - Working on slit 493
2025-09-13 16:52:57,384 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:52:57,385 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 30.00 (inclusive)
2025-09-13 16:52:57,527 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 16:52:58,591 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_03101_00001_nis_cal.fits>,).
2025-09-13 16:52:58,661 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 16:52:58,678 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 16:52:58,680 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 16:52:58,681 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 16:52:58,682 - jwst.combine_1d.combine1d - WARNING - 3 output pixel numbers were NaN
2025-09-13 16:52:58,682 - jwst.combine_1d.combine1d - WARNING - 30 elements of output had no corresponding input data;
2025-09-13 16:52:58,683 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 16:52:58,729 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 16:52:59,795 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faeb4892b10>,).
2025-09-13 16:52:59,796 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 16:53:00,904 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faeb4892b10>,).
2025-09-13 16:53:00,908 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 16:53:00,937 - jwst.extract_1d.extract - INFO - Working on slit 981
2025-09-13 16:53:00,938 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:53:00,939 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 19.00 (inclusive)
2025-09-13 16:53:00,992 - jwst.extract_1d.extract - INFO - Working on slit 981
2025-09-13 16:53:00,993 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:53:00,994 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 19.00 (inclusive)
2025-09-13 16:53:01,046 - jwst.extract_1d.extract - INFO - Working on slit 981
2025-09-13 16:53:01,047 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:53:01,048 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 20.00 (inclusive)
2025-09-13 16:53:01,189 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 16:53:02,300 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_03101_00001_nis_cal.fits>,).
2025-09-13 16:53:02,372 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 16:53:02,389 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 16:53:02,391 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 16:53:02,392 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 16:53:02,394 - jwst.combine_1d.combine1d - WARNING - 3 output pixel numbers were NaN
2025-09-13 16:53:02,394 - jwst.combine_1d.combine1d - WARNING - 24 elements of output had no corresponding input data;
2025-09-13 16:53:02,395 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 16:53:02,444 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 16:53:03,601 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faeb4892f00>,).
2025-09-13 16:53:03,602 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 16:53:04,715 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faeb4892f00>,).
2025-09-13 16:53:04,718 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 16:53:04,748 - jwst.extract_1d.extract - INFO - Working on slit 1371
2025-09-13 16:53:04,749 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:53:04,750 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 23.00 (inclusive)
2025-09-13 16:53:04,803 - jwst.extract_1d.extract - INFO - Working on slit 1371
2025-09-13 16:53:04,804 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:53:04,805 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 24.00 (inclusive)
2025-09-13 16:53:04,858 - jwst.extract_1d.extract - INFO - Working on slit 1371
2025-09-13 16:53:04,859 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:53:04,860 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 23.00 (inclusive)
2025-09-13 16:53:05,006 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 16:53:06,115 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_03101_00001_nis_cal.fits>,).
2025-09-13 16:53:06,183 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 16:53:06,200 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 16:53:06,201 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 16:53:06,202 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 16:53:06,204 - jwst.combine_1d.combine1d - WARNING - 2 output pixel numbers were NaN
2025-09-13 16:53:06,204 - jwst.combine_1d.combine1d - WARNING - 24 elements of output had no corresponding input data;
2025-09-13 16:53:06,204 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 16:53:06,252 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 16:53:07,353 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faeb48932f0>,).
2025-09-13 16:53:07,354 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 16:53:08,458 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faeb48932f0>,).
2025-09-13 16:53:08,461 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 16:53:08,504 - jwst.extract_1d.extract - INFO - Working on slit 536
2025-09-13 16:53:08,505 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:53:08,506 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 24.00 (inclusive)
2025-09-13 16:53:08,559 - jwst.extract_1d.extract - INFO - Working on slit 536
2025-09-13 16:53:08,560 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:53:08,560 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 23.00 (inclusive)
2025-09-13 16:53:08,613 - jwst.extract_1d.extract - INFO - Working on slit 536
2025-09-13 16:53:08,614 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:53:08,615 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 23.00 (inclusive)
2025-09-13 16:53:08,757 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 16:53:09,871 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_03101_00001_nis_cal.fits>,).
2025-09-13 16:53:09,942 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 16:53:09,960 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 16:53:09,962 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 16:53:09,963 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 16:53:09,964 - jwst.combine_1d.combine1d - WARNING - 3 output pixel numbers were NaN
2025-09-13 16:53:09,965 - jwst.combine_1d.combine1d - WARNING - 35 elements of output had no corresponding input data;
2025-09-13 16:53:09,965 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 16:53:10,013 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 16:53:11,145 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faeb48936e0>,).
2025-09-13 16:53:11,146 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 16:53:12,242 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faeb48936e0>,).
2025-09-13 16:53:12,246 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 16:53:12,275 - jwst.extract_1d.extract - INFO - Working on slit 749
2025-09-13 16:53:12,276 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:53:12,277 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 25.00 (inclusive)
2025-09-13 16:53:12,331 - jwst.extract_1d.extract - INFO - Working on slit 749
2025-09-13 16:53:12,332 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:53:12,332 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 26.00 (inclusive)
2025-09-13 16:53:12,385 - jwst.extract_1d.extract - INFO - Working on slit 749
2025-09-13 16:53:12,386 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:53:12,388 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 25.00 (inclusive)
2025-09-13 16:53:12,532 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 16:53:13,582 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_03101_00001_nis_cal.fits>,).
2025-09-13 16:53:13,651 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 16:53:13,667 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 16:53:13,668 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 16:53:13,669 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 16:53:13,671 - jwst.combine_1d.combine1d - WARNING - 3 output pixel numbers were NaN
2025-09-13 16:53:13,671 - jwst.combine_1d.combine1d - WARNING - 24 elements of output had no corresponding input data;
2025-09-13 16:53:13,672 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 16:53:13,719 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 16:53:14,796 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faeb4893ad0>,).
2025-09-13 16:53:14,797 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 16:53:15,851 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faeb4893ad0>,).
2025-09-13 16:53:15,854 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 16:53:15,884 - jwst.extract_1d.extract - INFO - Working on slit 345
2025-09-13 16:53:15,885 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:53:15,886 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 21.00 (inclusive)
2025-09-13 16:53:15,938 - jwst.extract_1d.extract - INFO - Working on slit 345
2025-09-13 16:53:15,939 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:53:15,940 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 22.00 (inclusive)
2025-09-13 16:53:15,992 - jwst.extract_1d.extract - INFO - Working on slit 345
2025-09-13 16:53:15,993 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:53:15,994 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 21.00 (inclusive)
2025-09-13 16:53:16,139 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 16:53:17,237 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_03101_00001_nis_cal.fits>,).
2025-09-13 16:53:17,306 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 16:53:17,323 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 16:53:17,324 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 16:53:17,325 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 16:53:17,326 - jwst.combine_1d.combine1d - WARNING - 3 output pixel numbers were NaN
2025-09-13 16:53:17,326 - jwst.combine_1d.combine1d - WARNING - 22 elements of output had no corresponding input data;
2025-09-13 16:53:17,327 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 16:53:17,374 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 16:53:18,442 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faeb4893ec0>,).
2025-09-13 16:53:18,442 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 16:53:19,491 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faeb4893ec0>,).
2025-09-13 16:53:19,495 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 16:53:19,524 - jwst.extract_1d.extract - INFO - Working on slit 721
2025-09-13 16:53:19,525 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type POINT
2025-09-13 16:53:19,526 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 10.00 (inclusive)
2025-09-13 16:53:19,533 - jwst.extract_1d.extract - INFO - Creating aperture correction.
2025-09-13 16:53:19,648 - jwst.extract_1d.extract - INFO - Working on slit 721
2025-09-13 16:53:19,649 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type POINT
2025-09-13 16:53:19,650 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 10.00 (inclusive)
2025-09-13 16:53:19,657 - jwst.extract_1d.extract - INFO - Creating aperture correction.
2025-09-13 16:53:19,775 - jwst.extract_1d.extract - INFO - Working on slit 721
2025-09-13 16:53:19,776 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type POINT
2025-09-13 16:53:19,777 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 10.00 (inclusive)
2025-09-13 16:53:19,784 - jwst.extract_1d.extract - INFO - Creating aperture correction.
2025-09-13 16:53:19,991 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 16:53:21,008 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_03101_00001_nis_cal.fits>,).
2025-09-13 16:53:21,075 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 16:53:21,091 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 16:53:21,092 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 16:53:21,094 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 16:53:21,095 - jwst.combine_1d.combine1d - WARNING - 3 output pixel numbers were NaN
2025-09-13 16:53:21,095 - jwst.combine_1d.combine1d - WARNING - 18 elements of output had no corresponding input data;
2025-09-13 16:53:21,096 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 16:53:21,142 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 16:53:22,175 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faeb48903b0>,).
2025-09-13 16:53:22,175 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 16:53:23,209 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faeb48903b0>,).
2025-09-13 16:53:23,212 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 16:53:23,242 - jwst.extract_1d.extract - INFO - Working on slit 387
2025-09-13 16:53:23,243 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:53:23,244 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 24.00 (inclusive)
2025-09-13 16:53:23,297 - jwst.extract_1d.extract - INFO - Working on slit 387
2025-09-13 16:53:23,298 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:53:23,299 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 24.00 (inclusive)
2025-09-13 16:53:23,351 - jwst.extract_1d.extract - INFO - Working on slit 387
2025-09-13 16:53:23,352 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:53:23,353 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 24.00 (inclusive)
2025-09-13 16:53:23,496 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 16:53:24,588 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_03101_00001_nis_cal.fits>,).
2025-09-13 16:53:24,659 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 16:53:24,675 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 16:53:24,677 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 16:53:24,678 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 16:53:24,679 - jwst.combine_1d.combine1d - WARNING - 2 output pixel numbers were NaN
2025-09-13 16:53:24,680 - jwst.combine_1d.combine1d - WARNING - 20 elements of output had no corresponding input data;
2025-09-13 16:53:24,681 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 16:53:24,728 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 16:53:25,832 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faeb40cc710>,).
2025-09-13 16:53:25,832 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 16:53:26,883 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faeb40cc710>,).
2025-09-13 16:53:26,886 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 16:53:26,916 - jwst.extract_1d.extract - INFO - Working on slit 505
2025-09-13 16:53:26,917 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:53:26,917 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 22.00 (inclusive)
2025-09-13 16:53:26,969 - jwst.extract_1d.extract - INFO - Working on slit 505
2025-09-13 16:53:26,970 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:53:26,971 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 22.00 (inclusive)
2025-09-13 16:53:27,022 - jwst.extract_1d.extract - INFO - Working on slit 505
2025-09-13 16:53:27,023 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:53:27,024 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 22.00 (inclusive)
2025-09-13 16:53:27,164 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 16:53:28,197 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_03101_00001_nis_cal.fits>,).
2025-09-13 16:53:28,265 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 16:53:28,282 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 16:53:28,283 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 16:53:28,284 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 16:53:28,285 - jwst.combine_1d.combine1d - WARNING - 3 output pixel numbers were NaN
2025-09-13 16:53:28,286 - jwst.combine_1d.combine1d - WARNING - 22 elements of output had no corresponding input data;
2025-09-13 16:53:28,286 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 16:53:28,333 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 16:53:29,455 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faeb40ccb00>,).
2025-09-13 16:53:29,456 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 16:53:30,556 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faeb40ccb00>,).
2025-09-13 16:53:30,560 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 16:53:30,589 - jwst.extract_1d.extract - INFO - Working on slit 566
2025-09-13 16:53:30,590 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:53:30,591 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 24.00 (inclusive)
2025-09-13 16:53:30,645 - jwst.extract_1d.extract - INFO - Working on slit 566
2025-09-13 16:53:30,646 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:53:30,647 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 24.00 (inclusive)
2025-09-13 16:53:30,700 - jwst.extract_1d.extract - INFO - Working on slit 566
2025-09-13 16:53:30,701 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:53:30,702 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 23.00 (inclusive)
2025-09-13 16:53:30,846 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 16:53:32,005 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_03101_00001_nis_cal.fits>,).
2025-09-13 16:53:32,075 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 16:53:32,093 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 16:53:32,094 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 16:53:32,096 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 16:53:32,097 - jwst.combine_1d.combine1d - WARNING - 2 output pixel numbers were NaN
2025-09-13 16:53:32,098 - jwst.combine_1d.combine1d - WARNING - 37 elements of output had no corresponding input data;
2025-09-13 16:53:32,098 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 16:53:32,146 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 16:53:33,356 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faeb40ccef0>,).
2025-09-13 16:53:33,357 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 16:53:34,503 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faeb40ccef0>,).
2025-09-13 16:53:34,506 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 16:53:34,536 - jwst.extract_1d.extract - INFO - Working on slit 772
2025-09-13 16:53:34,537 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:53:34,538 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 25.00 (inclusive)
2025-09-13 16:53:34,590 - jwst.extract_1d.extract - INFO - Working on slit 772
2025-09-13 16:53:34,591 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:53:34,592 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 25.00 (inclusive)
2025-09-13 16:53:34,644 - jwst.extract_1d.extract - INFO - Working on slit 772
2025-09-13 16:53:34,645 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:53:34,646 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 26.00 (inclusive)
2025-09-13 16:53:34,790 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 16:53:35,886 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_03101_00001_nis_cal.fits>,).
2025-09-13 16:53:35,955 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 16:53:35,972 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 16:53:35,973 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 16:53:35,974 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 16:53:35,975 - jwst.combine_1d.combine1d - WARNING - 2 output pixel numbers were NaN
2025-09-13 16:53:35,976 - jwst.combine_1d.combine1d - WARNING - 27 elements of output had no corresponding input data;
2025-09-13 16:53:35,976 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 16:53:36,023 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 16:53:37,108 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faeb40cd2e0>,).
2025-09-13 16:53:37,109 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 16:53:38,223 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faeb40cd2e0>,).
2025-09-13 16:53:38,226 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 16:53:38,259 - jwst.extract_1d.extract - INFO - Working on slit 722
2025-09-13 16:53:38,261 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:53:38,262 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 31.00 (inclusive)
2025-09-13 16:53:38,317 - jwst.extract_1d.extract - INFO - Working on slit 722
2025-09-13 16:53:38,318 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:53:38,319 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 31.00 (inclusive)
2025-09-13 16:53:38,373 - jwst.extract_1d.extract - INFO - Working on slit 722
2025-09-13 16:53:38,374 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:53:38,375 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 31.00 (inclusive)
2025-09-13 16:53:38,522 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 16:53:39,682 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_03101_00001_nis_cal.fits>,).
2025-09-13 16:53:39,752 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 16:53:39,770 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 16:53:39,771 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 16:53:39,773 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 16:53:39,774 - jwst.combine_1d.combine1d - WARNING - 2 output pixel numbers were NaN
2025-09-13 16:53:39,774 - jwst.combine_1d.combine1d - WARNING - 28 elements of output had no corresponding input data;
2025-09-13 16:53:39,775 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 16:53:39,825 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 16:53:40,968 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faeb40cd6d0>,).
2025-09-13 16:53:40,968 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 16:53:42,085 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faeb40cd6d0>,).
2025-09-13 16:53:42,088 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 16:53:42,118 - jwst.extract_1d.extract - INFO - Working on slit 872
2025-09-13 16:53:42,119 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type POINT
2025-09-13 16:53:42,120 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 10.00 (inclusive)
2025-09-13 16:53:42,127 - jwst.extract_1d.extract - INFO - Creating aperture correction.
2025-09-13 16:53:42,245 - jwst.extract_1d.extract - INFO - Working on slit 872
2025-09-13 16:53:42,246 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type POINT
2025-09-13 16:53:42,247 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 10.00 (inclusive)
2025-09-13 16:53:42,254 - jwst.extract_1d.extract - INFO - Creating aperture correction.
2025-09-13 16:53:42,373 - jwst.extract_1d.extract - INFO - Working on slit 872
2025-09-13 16:53:42,374 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type POINT
2025-09-13 16:53:42,375 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 10.00 (inclusive)
2025-09-13 16:53:42,382 - jwst.extract_1d.extract - INFO - Creating aperture correction.
2025-09-13 16:53:42,591 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 16:53:43,716 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_03101_00001_nis_cal.fits>,).
2025-09-13 16:53:43,786 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 16:53:43,801 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 16:53:43,803 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 16:53:43,804 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 16:53:43,805 - jwst.combine_1d.combine1d - WARNING - 2 output pixel numbers were NaN
2025-09-13 16:53:43,805 - jwst.combine_1d.combine1d - WARNING - 20 elements of output had no corresponding input data;
2025-09-13 16:53:43,806 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 16:53:43,852 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 16:53:44,894 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faeb40cdac0>,).
2025-09-13 16:53:44,894 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 16:53:45,944 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faeb40cdac0>,).
2025-09-13 16:53:45,947 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 16:53:45,978 - jwst.extract_1d.extract - INFO - Working on slit 933
2025-09-13 16:53:45,979 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:53:45,980 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 36.00 (inclusive)
2025-09-13 16:53:46,033 - jwst.extract_1d.extract - INFO - Working on slit 933
2025-09-13 16:53:46,035 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:53:46,036 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 37.00 (inclusive)
2025-09-13 16:53:46,089 - jwst.extract_1d.extract - INFO - Working on slit 933
2025-09-13 16:53:46,090 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:53:46,091 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 36.00 (inclusive)
2025-09-13 16:53:46,235 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 16:53:47,303 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_03101_00001_nis_cal.fits>,).
2025-09-13 16:53:47,371 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 16:53:47,388 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 16:53:47,390 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 16:53:47,391 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 16:53:47,392 - jwst.combine_1d.combine1d - WARNING - 3 output pixel numbers were NaN
2025-09-13 16:53:47,393 - jwst.combine_1d.combine1d - WARNING - 25 elements of output had no corresponding input data;
2025-09-13 16:53:47,393 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 16:53:47,440 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 16:53:48,492 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faeb40cdeb0>,).
2025-09-13 16:53:48,493 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 16:53:49,559 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faeb40cdeb0>,).
2025-09-13 16:53:49,562 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 16:53:49,592 - jwst.extract_1d.extract - INFO - Working on slit 1128
2025-09-13 16:53:49,593 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type POINT
2025-09-13 16:53:49,594 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 10.00 (inclusive)
2025-09-13 16:53:49,601 - jwst.extract_1d.extract - INFO - Creating aperture correction.
2025-09-13 16:53:49,716 - jwst.extract_1d.extract - INFO - Working on slit 1128
2025-09-13 16:53:49,717 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type POINT
2025-09-13 16:53:49,719 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 10.00 (inclusive)
2025-09-13 16:53:49,726 - jwst.extract_1d.extract - INFO - Creating aperture correction.
2025-09-13 16:53:49,841 - jwst.extract_1d.extract - INFO - Working on slit 1128
2025-09-13 16:53:49,842 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type POINT
2025-09-13 16:53:49,843 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 10.00 (inclusive)
2025-09-13 16:53:49,850 - jwst.extract_1d.extract - INFO - Creating aperture correction.
2025-09-13 16:53:50,054 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 16:53:51,105 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_03101_00001_nis_cal.fits>,).
2025-09-13 16:53:51,172 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 16:53:51,188 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 16:53:51,189 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 16:53:51,191 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 16:53:51,192 - jwst.combine_1d.combine1d - WARNING - 2 output pixel numbers were NaN
2025-09-13 16:53:51,192 - jwst.combine_1d.combine1d - WARNING - 16 elements of output had no corresponding input data;
2025-09-13 16:53:51,192 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 16:53:51,238 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 16:53:52,299 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faeb40ce2a0>,).
2025-09-13 16:53:52,300 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 16:53:53,391 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faeb40ce2a0>,).
2025-09-13 16:53:53,394 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 16:53:53,424 - jwst.extract_1d.extract - INFO - Working on slit 1282
2025-09-13 16:53:53,425 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:53:53,426 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 34.00 (inclusive)
2025-09-13 16:53:53,479 - jwst.extract_1d.extract - INFO - Working on slit 1282
2025-09-13 16:53:53,480 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:53:53,481 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 33.00 (inclusive)
2025-09-13 16:53:53,533 - jwst.extract_1d.extract - INFO - Working on slit 1282
2025-09-13 16:53:53,534 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:53:53,535 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 34.00 (inclusive)
2025-09-13 16:53:53,680 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 16:53:54,767 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_03101_00001_nis_cal.fits>,).
2025-09-13 16:53:54,834 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 16:53:54,851 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 16:53:54,853 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 16:53:54,854 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 16:53:54,855 - jwst.combine_1d.combine1d - WARNING - 2 output pixel numbers were NaN
2025-09-13 16:53:54,856 - jwst.combine_1d.combine1d - WARNING - 36 elements of output had no corresponding input data;
2025-09-13 16:53:54,856 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 16:53:54,902 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 16:53:55,942 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faeb40ce690>,).
2025-09-13 16:53:55,943 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 16:53:56,992 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faeb40ce690>,).
2025-09-13 16:53:56,995 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 16:53:57,025 - jwst.extract_1d.extract - INFO - Working on slit 274
2025-09-13 16:53:57,026 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:53:57,027 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 32.00 (inclusive)
2025-09-13 16:53:57,079 - jwst.extract_1d.extract - INFO - Working on slit 274
2025-09-13 16:53:57,080 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:53:57,081 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 31.00 (inclusive)
2025-09-13 16:53:57,133 - jwst.extract_1d.extract - INFO - Working on slit 274
2025-09-13 16:53:57,134 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:53:57,135 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 31.00 (inclusive)
2025-09-13 16:53:57,277 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 16:53:58,353 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_03101_00001_nis_cal.fits>,).
2025-09-13 16:53:58,422 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 16:53:58,440 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 16:53:58,441 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 16:53:58,442 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 16:53:58,443 - jwst.combine_1d.combine1d - WARNING - 3 output pixel numbers were NaN
2025-09-13 16:53:58,444 - jwst.combine_1d.combine1d - WARNING - 33 elements of output had no corresponding input data;
2025-09-13 16:53:58,444 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 16:53:58,491 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 16:53:59,540 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faeb40cea80>,).
2025-09-13 16:53:59,541 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 16:54:00,634 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faeb40cea80>,).
2025-09-13 16:54:00,637 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 16:54:00,668 - jwst.extract_1d.extract - INFO - Working on slit 641
2025-09-13 16:54:00,669 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:54:00,670 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 29.00 (inclusive)
2025-09-13 16:54:00,723 - jwst.extract_1d.extract - INFO - Working on slit 641
2025-09-13 16:54:00,725 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:54:00,726 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 29.00 (inclusive)
2025-09-13 16:54:00,778 - jwst.extract_1d.extract - INFO - Working on slit 641
2025-09-13 16:54:00,779 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:54:00,780 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 29.00 (inclusive)
2025-09-13 16:54:00,924 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 16:54:02,004 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_03101_00001_nis_cal.fits>,).
2025-09-13 16:54:02,071 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 16:54:02,088 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 16:54:02,090 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 16:54:02,091 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 16:54:02,092 - jwst.combine_1d.combine1d - WARNING - 2 output pixel numbers were NaN
2025-09-13 16:54:02,093 - jwst.combine_1d.combine1d - WARNING - 25 elements of output had no corresponding input data;
2025-09-13 16:54:02,093 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 16:54:02,141 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 16:54:03,231 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faeb40cee70>,).
2025-09-13 16:54:03,232 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 16:54:04,303 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faeb40cee70>,).
2025-09-13 16:54:04,306 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 16:54:04,335 - jwst.extract_1d.extract - INFO - Working on slit 543
2025-09-13 16:54:04,336 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:54:04,337 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 31.00 (inclusive)
2025-09-13 16:54:04,389 - jwst.extract_1d.extract - INFO - Working on slit 543
2025-09-13 16:54:04,390 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:54:04,390 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 32.00 (inclusive)
2025-09-13 16:54:04,441 - jwst.extract_1d.extract - INFO - Working on slit 543
2025-09-13 16:54:04,442 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:54:04,443 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 31.00 (inclusive)
2025-09-13 16:54:04,583 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 16:54:05,687 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_03101_00001_nis_cal.fits>,).
2025-09-13 16:54:05,754 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 16:54:05,771 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 16:54:05,772 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 16:54:05,773 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 16:54:05,775 - jwst.combine_1d.combine1d - WARNING - 2 output pixel numbers were NaN
2025-09-13 16:54:05,775 - jwst.combine_1d.combine1d - WARNING - 29 elements of output had no corresponding input data;
2025-09-13 16:54:05,775 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 16:54:05,822 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 16:54:06,902 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faeb40cf260>,).
2025-09-13 16:54:06,902 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 16:54:08,000 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faeb40cf260>,).
2025-09-13 16:54:08,003 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 16:54:08,033 - jwst.extract_1d.extract - INFO - Working on slit 1188
2025-09-13 16:54:08,034 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:54:08,035 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 17.00 (inclusive)
2025-09-13 16:54:08,087 - jwst.extract_1d.extract - INFO - Working on slit 1188
2025-09-13 16:54:08,088 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:54:08,089 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 18.00 (inclusive)
2025-09-13 16:54:08,141 - jwst.extract_1d.extract - INFO - Working on slit 1188
2025-09-13 16:54:08,142 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:54:08,143 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 17.00 (inclusive)
2025-09-13 16:54:08,284 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 16:54:09,383 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_03101_00001_nis_cal.fits>,).
2025-09-13 16:54:09,450 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 16:54:09,467 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 16:54:09,469 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 16:54:09,470 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 16:54:09,471 - jwst.combine_1d.combine1d - WARNING - 2 output pixel numbers were NaN
2025-09-13 16:54:09,472 - jwst.combine_1d.combine1d - WARNING - 39 elements of output had no corresponding input data;
2025-09-13 16:54:09,472 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 16:54:09,518 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 16:54:10,577 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faeb40cf650>,).
2025-09-13 16:54:10,578 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 16:54:11,632 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faeb40cf650>,).
2025-09-13 16:54:11,636 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 16:54:11,665 - jwst.extract_1d.extract - INFO - Working on slit 533
2025-09-13 16:54:11,666 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:54:11,667 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 25.00 (inclusive)
2025-09-13 16:54:11,719 - jwst.extract_1d.extract - INFO - Working on slit 533
2025-09-13 16:54:11,721 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:54:11,721 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 25.00 (inclusive)
2025-09-13 16:54:11,844 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 16:54:12,910 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_03101_00001_nis_cal.fits>,).
2025-09-13 16:54:12,961 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 16:54:12,974 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 16:54:12,975 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 16:54:12,976 - jwst.combine_1d.combine1d - WARNING - 1 output pixel numbers were NaN
2025-09-13 16:54:12,977 - jwst.combine_1d.combine1d - WARNING - 23 elements of output had no corresponding input data;
2025-09-13 16:54:12,978 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 16:54:13,023 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 16:54:14,066 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faeb40cc320>,).
2025-09-13 16:54:14,067 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 16:54:15,193 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faeb40cc320>,).
2025-09-13 16:54:15,196 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 16:54:15,226 - jwst.extract_1d.extract - INFO - Working on slit 1342
2025-09-13 16:54:15,227 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:54:15,228 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 21.00 (inclusive)
2025-09-13 16:54:15,281 - jwst.extract_1d.extract - INFO - Working on slit 1342
2025-09-13 16:54:15,282 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:54:15,283 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 21.00 (inclusive)
2025-09-13 16:54:15,407 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 16:54:16,502 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_03101_00001_nis_cal.fits>,).
2025-09-13 16:54:16,554 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 16:54:16,567 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 16:54:16,569 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 16:54:16,570 - jwst.combine_1d.combine1d - WARNING - 23 elements of output had no corresponding input data;
2025-09-13 16:54:16,570 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 16:54:16,617 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 16:54:17,706 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faeb40cfa40>,).
2025-09-13 16:54:17,707 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 16:54:18,806 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faeb40cfa40>,).
2025-09-13 16:54:18,809 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 16:54:18,838 - jwst.extract_1d.extract - INFO - Processing spectral order 1
2025-09-13 16:54:18,839 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:54:18,840 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 19.00 (inclusive)
2025-09-13 16:54:18,943 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 16:54:20,039 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_03101_00002_nis_cal.fits>,).
2025-09-13 16:54:20,074 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 16:54:20,081 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 16:54:20,082 - jwst.combine_1d.combine1d - WARNING - 14 elements of output had no corresponding input data;
2025-09-13 16:54:20,083 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 16:54:20,129 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 16:54:21,225 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faeb40cfd10>,).
2025-09-13 16:54:21,225 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 16:54:22,363 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faeb40cfd10>,).
2025-09-13 16:54:22,367 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 16:54:22,397 - jwst.extract_1d.extract - INFO - Processing spectral order 1
2025-09-13 16:54:22,398 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type POINT
2025-09-13 16:54:22,399 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 4.00 (inclusive)
2025-09-13 16:54:22,405 - jwst.extract_1d.extract - INFO - Creating aperture correction.
2025-09-13 16:54:22,586 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 16:54:23,703 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_03101_00002_nis_cal.fits>,).
2025-09-13 16:54:23,739 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 16:54:23,740 - jwst.combine_1d.combine1d - WARNING - Input spectrum 610 order 1 from group_id jw02079004003_03101_2_1 has no valid flux values; skipping.
2025-09-13 16:54:23,740 - jwst.combine_1d.combine1d - ERROR - No valid input spectra found for source. Skipping.
2025-09-13 16:54:23,749 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 16:54:24,848 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faeb372c200>,).
2025-09-13 16:54:24,849 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 16:54:25,944 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faeb372c200>,).
2025-09-13 16:54:25,948 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 16:54:25,978 - jwst.extract_1d.extract - INFO - Processing spectral order 1
2025-09-13 16:54:25,979 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:54:25,980 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 31.00 (inclusive)
2025-09-13 16:54:26,083 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 16:54:27,149 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_03101_00003_nis_cal.fits>,).
2025-09-13 16:54:27,185 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 16:54:27,194 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 16:54:27,195 - jwst.combine_1d.combine1d - WARNING - 24 elements of output had no corresponding input data;
2025-09-13 16:54:27,195 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 16:54:27,242 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 16:54:33,687 - stpipe.Spec3Pipeline - INFO - Saving the final x1d product as jw02079-o004_niriss_gr150r-f200w_x1d.fits.
2025-09-13 16:54:33,860 - stpipe.Spec3Pipeline - INFO - Saving the final c1d product as jw02079-o004_niriss_gr150r-f200w_c1d.fits.
2025-09-13 16:54:33,907 - stpipe.Spec3Pipeline - INFO - Ending calwebb_spec3
2025-09-13 16:54:34,035 - stpipe.Spec3Pipeline - INFO - Step Spec3Pipeline done
2025-09-13 16:54:34,037 - jwst.stpipe.core - INFO - Results used jwst version: 1.19.1
2025-09-13 16:54:34,046 - py.warnings - WARNING - /usr/share/miniconda/lib/python3.13/site-packages/jwst/associations/association.py:234: UserWarning: Input association file contains path information; note that this can complicate usage and/or sharing of such files.
warnings.warn(err_str, UserWarning, stacklevel=1)
2025-09-13 16:54:39,541 - stpipe.Spec3Pipeline - INFO - Spec3Pipeline instance created.
2025-09-13 16:54:39,542 - stpipe.Spec3Pipeline.assign_mtwcs - INFO - AssignMTWcsStep instance created.
2025-09-13 16:54:39,543 - stpipe.Spec3Pipeline.master_background - INFO - MasterBackgroundStep instance created.
2025-09-13 16:54:39,545 - stpipe.Spec3Pipeline.mrs_imatch - INFO - MRSIMatchStep instance created.
2025-09-13 16:54:39,546 - stpipe.Spec3Pipeline.outlier_detection - INFO - OutlierDetectionStep instance created.
2025-09-13 16:54:39,547 - stpipe.Spec3Pipeline.pixel_replace - INFO - PixelReplaceStep instance created.
2025-09-13 16:54:39,548 - stpipe.Spec3Pipeline.resample_spec - INFO - ResampleSpecStep instance created.
2025-09-13 16:54:39,549 - stpipe.Spec3Pipeline.cube_build - INFO - CubeBuildStep instance created.
2025-09-13 16:54:39,550 - stpipe.Spec3Pipeline.extract_1d - INFO - Extract1dStep instance created.
2025-09-13 16:54:39,551 - stpipe.Spec3Pipeline.photom - INFO - PhotomStep instance created.
2025-09-13 16:54:39,552 - stpipe.Spec3Pipeline.combine_1d - INFO - Combine1dStep instance created.
2025-09-13 16:54:39,553 - stpipe.Spec3Pipeline.spectral_leak - INFO - SpectralLeakStep instance created.
2025-09-13 16:54:39,965 - stpipe.Spec3Pipeline - INFO - Step Spec3Pipeline running with args ('/home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/jw02079-o004_niriss_gr150c-f200w_spec3_asn.json',).
2025-09-13 16:54:39,980 - stpipe.Spec3Pipeline - INFO - Step Spec3Pipeline parameters are:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage3_spec
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: True
skip: False
suffix: None
search_output_file: True
input_dir: ''
steps:
assign_mtwcs:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: True
output_use_index: True
save_results: False
skip: False
suffix: assign_mtwcs
search_output_file: True
input_dir: ''
master_background:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: True
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
median_kernel: 1
user_background: None
save_background: False
force_subtract: False
mrs_imatch:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: True
suffix: None
search_output_file: True
input_dir: ''
bkg_degree: 1
subtract: False
outlier_detection:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: False
input_dir: ''
weight_type: ivm
pixfrac: 1.0
kernel: square
fillval: NAN
maskpt: 0.7
snr: 5.0 4.0
scale: 1.2 0.7
backg: 0.0
kernel_size: 7 7
threshold_percent: 99.8
rolling_window_width: 25
ifu_second_check: False
save_intermediate_results: False
resample_data: True
good_bits: ~DO_NOT_USE
in_memory: True
pixel_replace:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: True
output_use_index: True
save_results: False
skip: True
suffix: None
search_output_file: True
input_dir: ''
algorithm: fit_profile
n_adjacent_cols: 3
resample_spec:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
pixfrac: 1.0
kernel: square
fillval: NAN
weight_type: ivm
output_shape: None
pixel_scale_ratio: 1.0
pixel_scale: None
output_wcs: ''
single: False
blendheaders: True
in_memory: True
cube_build:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: True
output_use_index: True
save_results: False
skip: False
suffix: s3d
search_output_file: False
input_dir: ''
channel: all
band: all
grating: all
filter: all
output_type: None
scalexy: 0.0
scalew: 0.0
weighting: drizzle
coord_system: skyalign
ra_center: None
dec_center: None
cube_pa: None
nspax_x: None
nspax_y: None
rois: 0.0
roiw: 0.0
weight_power: 2.0
wavemin: None
wavemax: None
single: False
skip_dqflagging: False
offset_file: None
debug_spaxel: -1 -1 -1
extract_1d:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
subtract_background: None
apply_apcorr: True
extraction_type: box
use_source_posn: None
position_offset: 0.0
model_nod_pair: True
optimize_psf_location: True
smoothing_length: None
bkg_fit: None
bkg_order: None
log_increment: 50
save_profile: False
save_scene_model: False
save_residual_image: False
center_xy: None
ifu_autocen: False
bkg_sigma_clip: 3.0
ifu_rfcorr: True
ifu_set_srctype: None
ifu_rscale: None
ifu_covar_scale: 1.0
soss_atoca: True
soss_threshold: 0.01
soss_n_os: 2
soss_wave_grid_in: None
soss_wave_grid_out: None
soss_estimate: None
soss_rtol: 0.0001
soss_max_grid_size: 20000
soss_tikfac: None
soss_width: 40.0
soss_bad_pix: masking
soss_modelname: None
photom:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
inverse: False
source_type: None
mrs_time_correction: True
combine_1d:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
exptime_key: exposure_time
sigma_clip: None
spectral_leak:
pre_hooks: []
post_hooks: []
output_file: None
output_dir: None
output_ext: .fits
output_use_model: False
output_use_index: True
save_results: False
skip: False
suffix: None
search_output_file: True
input_dir: ''
2025-09-13 16:54:44,098 - stpipe.Spec3Pipeline - INFO - Prefetching reference files for dataset: 'jw02079-o004_niriss_gr150c-f200w_spec3_asn.json' reftypes = ['apcorr', 'area', 'cubepar', 'extract1d', 'mrsptcorr', 'pastasoss', 'photom', 'psf', 'speckernel', 'specprofile']
2025-09-13 16:54:44,125 - stpipe.Spec3Pipeline - INFO - Prefetch for APCORR reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits'.
2025-09-13 16:54:44,126 - stpipe.Spec3Pipeline - INFO - Prefetch for AREA reference file is 'N/A'.
2025-09-13 16:54:44,126 - stpipe.Spec3Pipeline - INFO - Prefetch for CUBEPAR reference file is 'N/A'.
2025-09-13 16:54:44,127 - stpipe.Spec3Pipeline - INFO - Prefetch for EXTRACT1D reference file is 'N/A'.
2025-09-13 16:54:44,127 - stpipe.Spec3Pipeline - INFO - Prefetch for MRSPTCORR reference file is 'N/A'.
2025-09-13 16:54:44,127 - stpipe.Spec3Pipeline - INFO - Prefetch for PASTASOSS reference file is 'N/A'.
2025-09-13 16:54:44,128 - stpipe.Spec3Pipeline - INFO - Prefetch for PHOTOM reference file is '/home/runner/crds/references/jwst/niriss/jwst_niriss_photom_0041.fits'.
2025-09-13 16:54:44,128 - stpipe.Spec3Pipeline - INFO - Prefetch for PSF reference file is 'N/A'.
2025-09-13 16:54:44,128 - stpipe.Spec3Pipeline - INFO - Prefetch for SPECKERNEL reference file is 'N/A'.
2025-09-13 16:54:44,129 - stpipe.Spec3Pipeline - INFO - Prefetch for SPECPROFILE reference file is 'N/A'.
2025-09-13 16:54:44,129 - stpipe.Spec3Pipeline - INFO - Starting calwebb_spec3 ...
2025-09-13 16:55:10,240 - stpipe.Spec3Pipeline - INFO - Convert from exposure-based to source-based data.
2025-09-13 16:55:10,241 - jwst.exp_to_source.exp_to_source - INFO - Reorganizing data from exposure jw02079004003_05101_00001_nis_cal.fits
2025-09-13 16:55:18,321 - jwst.exp_to_source.exp_to_source - INFO - Reorganizing data from exposure jw02079004003_05101_00002_nis_cal.fits
2025-09-13 16:55:20,809 - jwst.exp_to_source.exp_to_source - INFO - Reorganizing data from exposure jw02079004003_05101_00003_nis_cal.fits
2025-09-13 16:55:27,100 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faebabc1a30>,).
2025-09-13 16:55:27,101 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 16:55:28,141 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faebabc1a30>,).
2025-09-13 16:55:28,145 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 16:55:28,174 - jwst.extract_1d.extract - INFO - Working on slit 522
2025-09-13 16:55:28,176 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:55:28,177 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 147.00 (inclusive)
2025-09-13 16:55:28,231 - jwst.extract_1d.extract - INFO - Working on slit 522
2025-09-13 16:55:28,232 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:55:28,234 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 147.00 (inclusive)
2025-09-13 16:55:28,287 - jwst.extract_1d.extract - INFO - Working on slit 522
2025-09-13 16:55:28,288 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:55:28,290 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 146.00 (inclusive)
2025-09-13 16:55:28,434 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 16:55:29,439 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_05101_00001_nis_cal.fits>,).
2025-09-13 16:55:29,507 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 16:55:29,530 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 16:55:29,532 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 16:55:29,533 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 16:55:29,535 - jwst.combine_1d.combine1d - WARNING - 3 output pixel numbers were NaN
2025-09-13 16:55:29,535 - jwst.combine_1d.combine1d - WARNING - 148 elements of output had no corresponding input data;
2025-09-13 16:55:29,535 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 16:55:29,582 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 16:55:30,618 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faebabc3260>,).
2025-09-13 16:55:30,619 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 16:55:31,636 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faebabc3260>,).
2025-09-13 16:55:31,639 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 16:55:31,670 - jwst.extract_1d.extract - INFO - Working on slit 796
2025-09-13 16:55:31,671 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:55:31,673 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 95.00 (inclusive)
2025-09-13 16:55:31,727 - jwst.extract_1d.extract - INFO - Working on slit 796
2025-09-13 16:55:31,728 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:55:31,730 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 95.00 (inclusive)
2025-09-13 16:55:31,783 - jwst.extract_1d.extract - INFO - Working on slit 796
2025-09-13 16:55:31,784 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:55:31,785 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 95.00 (inclusive)
2025-09-13 16:55:31,929 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 16:55:32,951 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_05101_00001_nis_cal.fits>,).
2025-09-13 16:55:33,022 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 16:55:33,044 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 16:55:33,045 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 16:55:33,047 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 16:55:33,049 - jwst.combine_1d.combine1d - WARNING - 3 output pixel numbers were NaN
2025-09-13 16:55:33,049 - jwst.combine_1d.combine1d - WARNING - 94 elements of output had no corresponding input data;
2025-09-13 16:55:33,050 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 16:55:33,099 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 16:55:34,154 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faebabc3020>,).
2025-09-13 16:55:34,155 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 16:55:35,227 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faebabc3020>,).
2025-09-13 16:55:35,230 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 16:55:35,261 - jwst.extract_1d.extract - INFO - Working on slit 1479
2025-09-13 16:55:35,263 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:55:35,264 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 40.00 (inclusive)
2025-09-13 16:55:35,319 - jwst.extract_1d.extract - INFO - Working on slit 1479
2025-09-13 16:55:35,321 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:55:35,322 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 22.00 (inclusive)
2025-09-13 16:55:35,375 - jwst.extract_1d.extract - INFO - Working on slit 1479
2025-09-13 16:55:35,376 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:55:35,378 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 56.00 (inclusive)
2025-09-13 16:55:35,522 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 16:55:36,560 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_05101_00001_nis_cal.fits>,).
2025-09-13 16:55:36,629 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 16:55:36,652 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 16:55:36,653 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 16:55:36,655 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 16:55:36,657 - jwst.combine_1d.combine1d - WARNING - 2 output pixel numbers were NaN
2025-09-13 16:55:36,657 - jwst.combine_1d.combine1d - WARNING - 104 elements of output had no corresponding input data;
2025-09-13 16:55:36,658 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 16:55:36,706 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 16:55:37,739 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faebabc0f80>,).
2025-09-13 16:55:37,739 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 16:55:38,753 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faebabc0f80>,).
2025-09-13 16:55:38,757 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 16:55:38,786 - jwst.extract_1d.extract - INFO - Working on slit 214
2025-09-13 16:55:38,787 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:55:38,788 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 104.00 (inclusive)
2025-09-13 16:55:38,841 - jwst.extract_1d.extract - INFO - Working on slit 214
2025-09-13 16:55:38,842 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:55:38,843 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 105.00 (inclusive)
2025-09-13 16:55:38,895 - jwst.extract_1d.extract - INFO - Working on slit 214
2025-09-13 16:55:38,896 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:55:38,897 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 105.00 (inclusive)
2025-09-13 16:55:39,038 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 16:55:40,031 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_05101_00001_nis_cal.fits>,).
2025-09-13 16:55:40,099 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 16:55:40,119 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 16:55:40,120 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 16:55:40,121 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 16:55:40,123 - jwst.combine_1d.combine1d - WARNING - 3 output pixel numbers were NaN
2025-09-13 16:55:40,123 - jwst.combine_1d.combine1d - WARNING - 87 elements of output had no corresponding input data;
2025-09-13 16:55:40,124 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 16:55:40,171 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 16:55:41,182 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faebabc0050>,).
2025-09-13 16:55:41,183 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 16:55:42,184 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faebabc0050>,).
2025-09-13 16:55:42,187 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 16:55:42,217 - jwst.extract_1d.extract - INFO - Working on slit 693
2025-09-13 16:55:42,218 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:55:42,219 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 75.00 (inclusive)
2025-09-13 16:55:42,271 - jwst.extract_1d.extract - INFO - Working on slit 693
2025-09-13 16:55:42,272 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:55:42,273 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 75.00 (inclusive)
2025-09-13 16:55:42,328 - jwst.extract_1d.extract - INFO - Working on slit 693
2025-09-13 16:55:42,329 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:55:42,330 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 75.00 (inclusive)
2025-09-13 16:55:42,471 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 16:55:43,458 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_05101_00001_nis_cal.fits>,).
2025-09-13 16:55:43,525 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 16:55:43,543 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 16:55:43,544 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 16:55:43,545 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 16:55:43,547 - jwst.combine_1d.combine1d - WARNING - 1 output pixel numbers were NaN
2025-09-13 16:55:43,547 - jwst.combine_1d.combine1d - WARNING - 69 elements of output had no corresponding input data;
2025-09-13 16:55:43,548 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 16:55:43,593 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 16:55:44,560 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faebabc3b60>,).
2025-09-13 16:55:44,561 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 16:55:45,548 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faebabc3b60>,).
2025-09-13 16:55:45,551 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 16:55:45,581 - jwst.extract_1d.extract - INFO - Working on slit 1120
2025-09-13 16:55:45,582 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:55:45,583 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 67.00 (inclusive)
2025-09-13 16:55:45,635 - jwst.extract_1d.extract - INFO - Working on slit 1120
2025-09-13 16:55:45,636 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:55:45,637 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 67.00 (inclusive)
2025-09-13 16:55:45,688 - jwst.extract_1d.extract - INFO - Working on slit 1120
2025-09-13 16:55:45,689 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:55:45,690 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 68.00 (inclusive)
2025-09-13 16:55:45,830 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 16:55:46,816 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_05101_00001_nis_cal.fits>,).
2025-09-13 16:55:46,882 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 16:55:46,903 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 16:55:46,904 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 16:55:46,906 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 16:55:46,907 - jwst.combine_1d.combine1d - WARNING - 3 output pixel numbers were NaN
2025-09-13 16:55:46,908 - jwst.combine_1d.combine1d - WARNING - 109 elements of output had no corresponding input data;
2025-09-13 16:55:46,908 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 16:55:46,954 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 16:55:47,968 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faebabc0cb0>,).
2025-09-13 16:55:47,969 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 16:55:48,965 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faebabc0cb0>,).
2025-09-13 16:55:48,969 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 16:55:48,999 - jwst.extract_1d.extract - INFO - Working on slit 1257
2025-09-13 16:55:49,000 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:55:49,001 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 76.00 (inclusive)
2025-09-13 16:55:49,054 - jwst.extract_1d.extract - INFO - Working on slit 1257
2025-09-13 16:55:49,056 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:55:49,057 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 76.00 (inclusive)
2025-09-13 16:55:49,109 - jwst.extract_1d.extract - INFO - Working on slit 1257
2025-09-13 16:55:49,111 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:55:49,112 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 76.00 (inclusive)
2025-09-13 16:55:49,255 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 16:55:50,206 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_05101_00001_nis_cal.fits>,).
2025-09-13 16:55:50,273 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 16:55:50,293 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 16:55:50,295 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 16:55:50,296 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 16:55:50,297 - jwst.combine_1d.combine1d - WARNING - 2 output pixel numbers were NaN
2025-09-13 16:55:50,298 - jwst.combine_1d.combine1d - WARNING - 102 elements of output had no corresponding input data;
2025-09-13 16:55:50,298 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 16:55:50,344 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 16:55:51,309 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faebabc1eb0>,).
2025-09-13 16:55:51,309 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 16:55:52,295 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faebabc1eb0>,).
2025-09-13 16:55:52,299 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 16:55:52,328 - jwst.extract_1d.extract - INFO - Working on slit 766
2025-09-13 16:55:52,329 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:55:52,330 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 103.00 (inclusive)
2025-09-13 16:55:52,383 - jwst.extract_1d.extract - INFO - Working on slit 766
2025-09-13 16:55:52,384 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:55:52,385 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 102.00 (inclusive)
2025-09-13 16:55:52,436 - jwst.extract_1d.extract - INFO - Working on slit 766
2025-09-13 16:55:52,437 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:55:52,438 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 102.00 (inclusive)
2025-09-13 16:55:52,577 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 16:55:53,549 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_05101_00001_nis_cal.fits>,).
2025-09-13 16:55:53,616 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 16:55:53,633 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 16:55:53,634 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 16:55:53,636 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 16:55:53,637 - jwst.combine_1d.combine1d - WARNING - 2 output pixel numbers were NaN
2025-09-13 16:55:53,638 - jwst.combine_1d.combine1d - WARNING - 52 elements of output had no corresponding input data;
2025-09-13 16:55:53,638 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 16:55:53,685 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 16:55:54,660 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faee8d08290>,).
2025-09-13 16:55:54,661 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 16:55:55,658 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faee8d08290>,).
2025-09-13 16:55:55,662 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 16:55:55,692 - jwst.extract_1d.extract - INFO - Working on slit 606
2025-09-13 16:55:55,693 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type POINT
2025-09-13 16:55:55,694 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 10.00 (inclusive)
2025-09-13 16:55:55,701 - jwst.extract_1d.extract - INFO - Creating aperture correction.
2025-09-13 16:55:55,842 - jwst.extract_1d.extract - INFO - Working on slit 606
2025-09-13 16:55:55,843 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type POINT
2025-09-13 16:55:55,844 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 10.00 (inclusive)
2025-09-13 16:55:55,851 - jwst.extract_1d.extract - INFO - Creating aperture correction.
2025-09-13 16:55:55,993 - jwst.extract_1d.extract - INFO - Working on slit 606
2025-09-13 16:55:55,994 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type POINT
2025-09-13 16:55:55,995 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 10.00 (inclusive)
2025-09-13 16:55:56,002 - jwst.extract_1d.extract - INFO - Creating aperture correction.
2025-09-13 16:55:56,236 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 16:55:57,226 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_05101_00001_nis_cal.fits>,).
2025-09-13 16:55:57,294 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 16:55:57,312 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 16:55:57,313 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 16:55:57,314 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 16:55:57,316 - jwst.combine_1d.combine1d - WARNING - 3 output pixel numbers were NaN
2025-09-13 16:55:57,316 - jwst.combine_1d.combine1d - WARNING - 72 elements of output had no corresponding input data;
2025-09-13 16:55:57,317 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 16:55:57,362 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 16:55:58,315 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faee8d09ac0>,).
2025-09-13 16:55:58,316 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 16:55:59,284 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faee8d09ac0>,).
2025-09-13 16:55:59,287 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 16:55:59,316 - jwst.extract_1d.extract - INFO - Working on slit 649
2025-09-13 16:55:59,318 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:55:59,319 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 94.00 (inclusive)
2025-09-13 16:55:59,371 - jwst.extract_1d.extract - INFO - Working on slit 649
2025-09-13 16:55:59,373 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:55:59,374 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 94.00 (inclusive)
2025-09-13 16:55:59,424 - jwst.extract_1d.extract - INFO - Working on slit 649
2025-09-13 16:55:59,425 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:55:59,426 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 94.00 (inclusive)
2025-09-13 16:55:59,566 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 16:56:00,540 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_05101_00001_nis_cal.fits>,).
2025-09-13 16:56:00,608 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 16:56:00,628 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 16:56:00,630 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 16:56:00,631 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 16:56:00,632 - jwst.combine_1d.combine1d - WARNING - 3 output pixel numbers were NaN
2025-09-13 16:56:00,633 - jwst.combine_1d.combine1d - WARNING - 91 elements of output had no corresponding input data;
2025-09-13 16:56:00,633 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 16:56:00,680 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 16:56:01,659 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faef7bfb410>,).
2025-09-13 16:56:01,660 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 16:56:02,715 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faef7bfb410>,).
2025-09-13 16:56:02,719 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 16:56:02,750 - jwst.extract_1d.extract - INFO - Working on slit 982
2025-09-13 16:56:02,751 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:56:02,752 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 54.00 (inclusive)
2025-09-13 16:56:02,807 - jwst.extract_1d.extract - INFO - Working on slit 982
2025-09-13 16:56:02,808 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:56:02,809 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 55.00 (inclusive)
2025-09-13 16:56:02,863 - jwst.extract_1d.extract - INFO - Working on slit 982
2025-09-13 16:56:02,865 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:56:02,865 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 54.00 (inclusive)
2025-09-13 16:56:03,008 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 16:56:04,011 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_05101_00001_nis_cal.fits>,).
2025-09-13 16:56:04,081 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 16:56:04,099 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 16:56:04,100 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 16:56:04,101 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 16:56:04,103 - jwst.combine_1d.combine1d - WARNING - 3 output pixel numbers were NaN
2025-09-13 16:56:04,103 - jwst.combine_1d.combine1d - WARNING - 50 elements of output had no corresponding input data;
2025-09-13 16:56:04,104 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 16:56:04,151 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 16:56:05,124 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faef7bfa7b0>,).
2025-09-13 16:56:05,125 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 16:56:06,120 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faef7bfa7b0>,).
2025-09-13 16:56:06,123 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 16:56:06,153 - jwst.extract_1d.extract - INFO - Working on slit 1364
2025-09-13 16:56:06,154 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:56:06,155 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 60.00 (inclusive)
2025-09-13 16:56:06,208 - jwst.extract_1d.extract - INFO - Working on slit 1364
2025-09-13 16:56:06,209 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:56:06,210 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 60.00 (inclusive)
2025-09-13 16:56:06,261 - jwst.extract_1d.extract - INFO - Working on slit 1364
2025-09-13 16:56:06,262 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:56:06,263 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 59.00 (inclusive)
2025-09-13 16:56:06,405 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 16:56:07,384 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_05101_00001_nis_cal.fits>,).
2025-09-13 16:56:07,451 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 16:56:07,468 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 16:56:07,470 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 16:56:07,471 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 16:56:07,472 - jwst.combine_1d.combine1d - WARNING - 2 output pixel numbers were NaN
2025-09-13 16:56:07,473 - jwst.combine_1d.combine1d - WARNING - 44 elements of output had no corresponding input data;
2025-09-13 16:56:07,473 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 16:56:07,521 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 16:56:08,493 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faebde530b0>,).
2025-09-13 16:56:08,494 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 16:56:09,478 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faebde530b0>,).
2025-09-13 16:56:09,482 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 16:56:09,511 - jwst.extract_1d.extract - INFO - Working on slit 898
2025-09-13 16:56:09,512 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type POINT
2025-09-13 16:56:09,513 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 10.00 (inclusive)
2025-09-13 16:56:09,520 - jwst.extract_1d.extract - INFO - Creating aperture correction.
2025-09-13 16:56:09,648 - jwst.extract_1d.extract - INFO - Working on slit 898
2025-09-13 16:56:09,649 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type POINT
2025-09-13 16:56:09,649 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 10.00 (inclusive)
2025-09-13 16:56:09,656 - jwst.extract_1d.extract - INFO - Creating aperture correction.
2025-09-13 16:56:09,786 - jwst.extract_1d.extract - INFO - Working on slit 898
2025-09-13 16:56:09,787 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type POINT
2025-09-13 16:56:09,788 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 10.00 (inclusive)
2025-09-13 16:56:09,795 - jwst.extract_1d.extract - INFO - Creating aperture correction.
2025-09-13 16:56:10,020 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 16:56:11,036 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_05101_00001_nis_cal.fits>,).
2025-09-13 16:56:11,103 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 16:56:11,121 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 16:56:11,122 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 16:56:11,124 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 16:56:11,125 - jwst.combine_1d.combine1d - WARNING - 3 output pixel numbers were NaN
2025-09-13 16:56:11,126 - jwst.combine_1d.combine1d - WARNING - 45 elements of output had no corresponding input data;
2025-09-13 16:56:11,126 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 16:56:11,173 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 16:56:12,147 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faebde52600>,).
2025-09-13 16:56:12,148 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 16:56:13,104 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faebde52600>,).
2025-09-13 16:56:13,108 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 16:56:13,137 - jwst.extract_1d.extract - INFO - Working on slit 1049
2025-09-13 16:56:13,138 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:56:13,139 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 76.00 (inclusive)
2025-09-13 16:56:13,190 - jwst.extract_1d.extract - INFO - Working on slit 1049
2025-09-13 16:56:13,191 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:56:13,192 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 75.00 (inclusive)
2025-09-13 16:56:13,243 - jwst.extract_1d.extract - INFO - Working on slit 1049
2025-09-13 16:56:13,244 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:56:13,245 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 75.00 (inclusive)
2025-09-13 16:56:13,383 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 16:56:14,333 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_05101_00001_nis_cal.fits>,).
2025-09-13 16:56:14,400 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 16:56:14,400 - jwst.combine_1d.combine1d - WARNING - Input spectrum 1049 order 1 from group_id jw02079004003_05101_1_1 has no valid flux values; skipping.
2025-09-13 16:56:14,401 - jwst.combine_1d.combine1d - WARNING - Input spectrum 1049 order 1 from group_id jw02079004003_05101_2_1 has no valid flux values; skipping.
2025-09-13 16:56:14,401 - jwst.combine_1d.combine1d - WARNING - Input spectrum 1049 order 1 from group_id jw02079004003_05101_3_1 has no valid flux values; skipping.
2025-09-13 16:56:14,402 - jwst.combine_1d.combine1d - ERROR - No valid input spectra found for source. Skipping.
2025-09-13 16:56:14,410 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 16:56:15,394 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faebde50830>,).
2025-09-13 16:56:15,395 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 16:56:16,381 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faebde50830>,).
2025-09-13 16:56:16,384 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 16:56:16,414 - jwst.extract_1d.extract - INFO - Working on slit 732
2025-09-13 16:56:16,415 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:56:16,416 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 43.00 (inclusive)
2025-09-13 16:56:16,469 - jwst.extract_1d.extract - INFO - Working on slit 732
2025-09-13 16:56:16,470 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:56:16,471 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 44.00 (inclusive)
2025-09-13 16:56:16,523 - jwst.extract_1d.extract - INFO - Working on slit 732
2025-09-13 16:56:16,524 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:56:16,525 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 43.00 (inclusive)
2025-09-13 16:56:16,667 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 16:56:17,692 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_05101_00001_nis_cal.fits>,).
2025-09-13 16:56:17,760 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 16:56:17,779 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 16:56:17,780 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 16:56:17,781 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 16:56:17,783 - jwst.combine_1d.combine1d - WARNING - 3 output pixel numbers were NaN
2025-09-13 16:56:17,783 - jwst.combine_1d.combine1d - WARNING - 65 elements of output had no corresponding input data;
2025-09-13 16:56:17,784 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 16:56:17,830 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 16:56:18,824 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faebde52ba0>,).
2025-09-13 16:56:18,824 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 16:56:19,817 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faebde52ba0>,).
2025-09-13 16:56:19,820 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 16:56:19,849 - jwst.extract_1d.extract - INFO - Working on slit 189
2025-09-13 16:56:19,850 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:56:19,851 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 47.00 (inclusive)
2025-09-13 16:56:19,903 - jwst.extract_1d.extract - INFO - Working on slit 189
2025-09-13 16:56:19,904 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:56:19,905 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 46.00 (inclusive)
2025-09-13 16:56:19,956 - jwst.extract_1d.extract - INFO - Working on slit 189
2025-09-13 16:56:19,957 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:56:19,958 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 46.00 (inclusive)
2025-09-13 16:56:20,098 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 16:56:21,095 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_05101_00001_nis_cal.fits>,).
2025-09-13 16:56:21,163 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 16:56:21,180 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 16:56:21,182 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 16:56:21,183 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 16:56:21,185 - jwst.combine_1d.combine1d - WARNING - 3 output pixel numbers were NaN
2025-09-13 16:56:21,185 - jwst.combine_1d.combine1d - WARNING - 49 elements of output had no corresponding input data;
2025-09-13 16:56:21,185 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 16:56:21,233 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 16:56:22,224 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faebde516d0>,).
2025-09-13 16:56:22,225 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 16:56:23,204 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faebde516d0>,).
2025-09-13 16:56:23,207 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 16:56:23,236 - jwst.extract_1d.extract - INFO - Working on slit 881
2025-09-13 16:56:23,237 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type POINT
2025-09-13 16:56:23,238 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 10.00 (inclusive)
2025-09-13 16:56:23,245 - jwst.extract_1d.extract - INFO - Creating aperture correction.
2025-09-13 16:56:23,383 - jwst.extract_1d.extract - INFO - Working on slit 881
2025-09-13 16:56:23,384 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type POINT
2025-09-13 16:56:23,385 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 10.00 (inclusive)
2025-09-13 16:56:23,392 - jwst.extract_1d.extract - INFO - Creating aperture correction.
2025-09-13 16:56:23,532 - jwst.extract_1d.extract - INFO - Working on slit 881
2025-09-13 16:56:23,533 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type POINT
2025-09-13 16:56:23,534 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 10.00 (inclusive)
2025-09-13 16:56:23,541 - jwst.extract_1d.extract - INFO - Creating aperture correction.
2025-09-13 16:56:23,772 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 16:56:24,829 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_05101_00001_nis_cal.fits>,).
2025-09-13 16:56:24,896 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 16:56:24,915 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 16:56:24,916 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 16:56:24,917 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 16:56:24,919 - jwst.combine_1d.combine1d - WARNING - 3 output pixel numbers were NaN
2025-09-13 16:56:24,919 - jwst.combine_1d.combine1d - WARNING - 70 elements of output had no corresponding input data;
2025-09-13 16:56:24,920 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 16:56:24,966 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 16:56:26,008 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faebde51520>,).
2025-09-13 16:56:26,009 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 16:56:27,021 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faebde51520>,).
2025-09-13 16:56:27,024 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 16:56:27,053 - jwst.extract_1d.extract - INFO - Working on slit 966
2025-09-13 16:56:27,054 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:56:27,055 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 59.00 (inclusive)
2025-09-13 16:56:27,108 - jwst.extract_1d.extract - INFO - Working on slit 966
2025-09-13 16:56:27,109 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:56:27,110 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 59.00 (inclusive)
2025-09-13 16:56:27,163 - jwst.extract_1d.extract - INFO - Working on slit 966
2025-09-13 16:56:27,165 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:56:27,166 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 58.00 (inclusive)
2025-09-13 16:56:27,310 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 16:56:28,288 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_05101_00001_nis_cal.fits>,).
2025-09-13 16:56:28,356 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 16:56:28,374 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 16:56:28,376 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 16:56:28,377 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 16:56:28,378 - jwst.combine_1d.combine1d - WARNING - 3 output pixel numbers were NaN
2025-09-13 16:56:28,379 - jwst.combine_1d.combine1d - WARNING - 55 elements of output had no corresponding input data;
2025-09-13 16:56:28,379 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 16:56:28,426 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 16:56:29,452 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faebde51be0>,).
2025-09-13 16:56:29,453 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 16:56:30,450 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faebde51be0>,).
2025-09-13 16:56:30,453 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 16:56:30,483 - jwst.extract_1d.extract - INFO - Working on slit 914
2025-09-13 16:56:30,484 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:56:30,485 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 31.00 (inclusive)
2025-09-13 16:56:30,538 - jwst.extract_1d.extract - INFO - Working on slit 914
2025-09-13 16:56:30,539 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:56:30,540 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 31.00 (inclusive)
2025-09-13 16:56:30,591 - jwst.extract_1d.extract - INFO - Working on slit 914
2025-09-13 16:56:30,592 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:56:30,593 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 31.00 (inclusive)
2025-09-13 16:56:30,738 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 16:56:31,748 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_05101_00001_nis_cal.fits>,).
2025-09-13 16:56:31,817 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 16:56:31,835 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 16:56:31,836 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 16:56:31,838 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 16:56:31,839 - jwst.combine_1d.combine1d - WARNING - 2 output pixel numbers were NaN
2025-09-13 16:56:31,839 - jwst.combine_1d.combine1d - WARNING - 43 elements of output had no corresponding input data;
2025-09-13 16:56:31,840 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 16:56:31,887 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 16:56:32,900 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faef3c8af90>,).
2025-09-13 16:56:32,900 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 16:56:33,923 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faef3c8af90>,).
2025-09-13 16:56:33,926 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 16:56:33,955 - jwst.extract_1d.extract - INFO - Working on slit 1084
2025-09-13 16:56:33,956 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type POINT
2025-09-13 16:56:33,957 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 10.00 (inclusive)
2025-09-13 16:56:33,964 - jwst.extract_1d.extract - INFO - Creating aperture correction.
2025-09-13 16:56:34,094 - jwst.extract_1d.extract - INFO - Working on slit 1084
2025-09-13 16:56:34,095 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type POINT
2025-09-13 16:56:34,096 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 10.00 (inclusive)
2025-09-13 16:56:34,103 - jwst.extract_1d.extract - INFO - Creating aperture correction.
2025-09-13 16:56:34,234 - jwst.extract_1d.extract - INFO - Working on slit 1084
2025-09-13 16:56:34,235 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type POINT
2025-09-13 16:56:34,236 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 10.00 (inclusive)
2025-09-13 16:56:34,243 - jwst.extract_1d.extract - INFO - Creating aperture correction.
2025-09-13 16:56:34,464 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 16:56:35,447 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_05101_00001_nis_cal.fits>,).
2025-09-13 16:56:35,514 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 16:56:35,532 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 16:56:35,534 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 16:56:35,535 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 16:56:35,537 - jwst.combine_1d.combine1d - WARNING - 2 output pixel numbers were NaN
2025-09-13 16:56:35,537 - jwst.combine_1d.combine1d - WARNING - 52 elements of output had no corresponding input data;
2025-09-13 16:56:35,538 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 16:56:35,584 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 16:56:36,577 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faef3c8b380>,).
2025-09-13 16:56:36,578 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 16:56:37,576 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faef3c8b380>,).
2025-09-13 16:56:37,579 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 16:56:37,609 - jwst.extract_1d.extract - INFO - Working on slit 540
2025-09-13 16:56:37,610 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:56:37,611 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 71.00 (inclusive)
2025-09-13 16:56:37,665 - jwst.extract_1d.extract - INFO - Working on slit 540
2025-09-13 16:56:37,666 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:56:37,667 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 71.00 (inclusive)
2025-09-13 16:56:37,719 - jwst.extract_1d.extract - INFO - Working on slit 540
2025-09-13 16:56:37,721 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:56:37,722 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 71.00 (inclusive)
2025-09-13 16:56:37,865 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 16:56:38,892 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_05101_00001_nis_cal.fits>,).
2025-09-13 16:56:38,961 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 16:56:38,980 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 16:56:38,981 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 16:56:38,982 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 16:56:38,984 - jwst.combine_1d.combine1d - WARNING - 2 output pixel numbers were NaN
2025-09-13 16:56:38,984 - jwst.combine_1d.combine1d - WARNING - 62 elements of output had no corresponding input data;
2025-09-13 16:56:38,985 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 16:56:39,032 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 16:56:40,059 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faef3c88a70>,).
2025-09-13 16:56:40,059 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 16:56:41,033 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faef3c88a70>,).
2025-09-13 16:56:41,036 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 16:56:41,066 - jwst.extract_1d.extract - INFO - Working on slit 1476
2025-09-13 16:56:41,067 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:56:41,068 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 42.00 (inclusive)
2025-09-13 16:56:41,120 - jwst.extract_1d.extract - INFO - Working on slit 1476
2025-09-13 16:56:41,121 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:56:41,122 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 24.00 (inclusive)
2025-09-13 16:56:41,173 - jwst.extract_1d.extract - INFO - Working on slit 1476
2025-09-13 16:56:41,174 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:56:41,175 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 58.00 (inclusive)
2025-09-13 16:56:41,316 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 16:56:42,294 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_05101_00001_nis_cal.fits>,).
2025-09-13 16:56:42,362 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 16:56:42,373 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 16:56:42,374 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 16:56:42,375 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 16:56:42,376 - jwst.combine_1d.combine1d - WARNING - 1 output pixel numbers were NaN
2025-09-13 16:56:42,377 - jwst.combine_1d.combine1d - WARNING - 29 elements of output had no corresponding input data;
2025-09-13 16:56:42,377 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 16:56:42,423 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 16:56:43,433 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faef3c89370>,).
2025-09-13 16:56:43,434 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 16:56:44,474 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faef3c89370>,).
2025-09-13 16:56:44,478 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 16:56:44,507 - jwst.extract_1d.extract - INFO - Working on slit 1142
2025-09-13 16:56:44,508 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:56:44,510 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 45.00 (inclusive)
2025-09-13 16:56:44,562 - jwst.extract_1d.extract - INFO - Working on slit 1142
2025-09-13 16:56:44,563 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:56:44,564 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 46.00 (inclusive)
2025-09-13 16:56:44,616 - jwst.extract_1d.extract - INFO - Working on slit 1142
2025-09-13 16:56:44,617 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:56:44,618 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 45.00 (inclusive)
2025-09-13 16:56:44,762 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 16:56:45,821 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_05101_00001_nis_cal.fits>,).
2025-09-13 16:56:45,888 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 16:56:45,904 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 16:56:45,905 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 16:56:45,906 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 16:56:45,908 - jwst.combine_1d.combine1d - WARNING - 1 output pixel numbers were NaN
2025-09-13 16:56:45,908 - jwst.combine_1d.combine1d - WARNING - 27 elements of output had no corresponding input data;
2025-09-13 16:56:45,909 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 16:56:45,955 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 16:56:46,975 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faef3c89be0>,).
2025-09-13 16:56:46,975 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 16:56:47,950 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faef3c89be0>,).
2025-09-13 16:56:47,954 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 16:56:47,983 - jwst.extract_1d.extract - INFO - Working on slit 220
2025-09-13 16:56:47,984 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type POINT
2025-09-13 16:56:47,984 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 10.00 (inclusive)
2025-09-13 16:56:47,991 - jwst.extract_1d.extract - INFO - Creating aperture correction.
2025-09-13 16:56:48,119 - jwst.extract_1d.extract - INFO - Working on slit 220
2025-09-13 16:56:48,120 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type POINT
2025-09-13 16:56:48,121 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 10.00 (inclusive)
2025-09-13 16:56:48,128 - jwst.extract_1d.extract - INFO - Creating aperture correction.
2025-09-13 16:56:48,257 - jwst.extract_1d.extract - INFO - Working on slit 220
2025-09-13 16:56:48,258 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type POINT
2025-09-13 16:56:48,259 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 10.00 (inclusive)
2025-09-13 16:56:48,266 - jwst.extract_1d.extract - INFO - Creating aperture correction.
2025-09-13 16:56:48,487 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 16:56:49,482 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_05101_00001_nis_cal.fits>,).
2025-09-13 16:56:49,549 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 16:56:49,566 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 16:56:49,568 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 16:56:49,569 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 16:56:49,570 - jwst.combine_1d.combine1d - WARNING - 3 output pixel numbers were NaN
2025-09-13 16:56:49,571 - jwst.combine_1d.combine1d - WARNING - 50 elements of output had no corresponding input data;
2025-09-13 16:56:49,571 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 16:56:49,618 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 16:56:50,596 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faef3c88c20>,).
2025-09-13 16:56:50,597 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 16:56:51,607 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faef3c88c20>,).
2025-09-13 16:56:51,610 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 16:56:51,640 - jwst.extract_1d.extract - INFO - Working on slit 289
2025-09-13 16:56:51,641 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:56:51,642 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 36.00 (inclusive)
2025-09-13 16:56:51,696 - jwst.extract_1d.extract - INFO - Working on slit 289
2025-09-13 16:56:51,697 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:56:51,698 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 35.00 (inclusive)
2025-09-13 16:56:51,749 - jwst.extract_1d.extract - INFO - Working on slit 289
2025-09-13 16:56:51,750 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:56:51,751 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 35.00 (inclusive)
2025-09-13 16:56:51,890 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 16:56:52,906 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_05101_00001_nis_cal.fits>,).
2025-09-13 16:56:52,974 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 16:56:52,993 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 16:56:52,995 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 16:56:52,996 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 16:56:52,998 - jwst.combine_1d.combine1d - WARNING - 3 output pixel numbers were NaN
2025-09-13 16:56:52,998 - jwst.combine_1d.combine1d - WARNING - 49 elements of output had no corresponding input data;
2025-09-13 16:56:52,998 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 16:56:53,049 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 16:56:54,112 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faef3c89c70>,).
2025-09-13 16:56:54,113 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 16:56:55,105 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faef3c89c70>,).
2025-09-13 16:56:55,108 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 16:56:55,138 - jwst.extract_1d.extract - INFO - Working on slit 934
2025-09-13 16:56:55,139 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:56:55,140 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 46.00 (inclusive)
2025-09-13 16:56:55,194 - jwst.extract_1d.extract - INFO - Working on slit 934
2025-09-13 16:56:55,195 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:56:55,196 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 46.00 (inclusive)
2025-09-13 16:56:55,249 - jwst.extract_1d.extract - INFO - Working on slit 934
2025-09-13 16:56:55,250 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:56:55,251 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 47.00 (inclusive)
2025-09-13 16:56:55,394 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 16:56:56,384 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_05101_00001_nis_cal.fits>,).
2025-09-13 16:56:56,452 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 16:56:56,469 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 16:56:56,471 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 16:56:56,472 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 16:56:56,473 - jwst.combine_1d.combine1d - WARNING - 3 output pixel numbers were NaN
2025-09-13 16:56:56,473 - jwst.combine_1d.combine1d - WARNING - 50 elements of output had no corresponding input data;
2025-09-13 16:56:56,474 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 16:56:56,519 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 16:56:57,509 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faef3c89d90>,).
2025-09-13 16:56:57,509 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 16:56:58,502 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faef3c89d90>,).
2025-09-13 16:56:58,505 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 16:56:58,535 - jwst.extract_1d.extract - INFO - Working on slit 1219
2025-09-13 16:56:58,536 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:56:58,537 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 59.00 (inclusive)
2025-09-13 16:56:58,589 - jwst.extract_1d.extract - INFO - Working on slit 1219
2025-09-13 16:56:58,591 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:56:58,592 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 60.00 (inclusive)
2025-09-13 16:56:58,644 - jwst.extract_1d.extract - INFO - Working on slit 1219
2025-09-13 16:56:58,645 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:56:58,646 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 60.00 (inclusive)
2025-09-13 16:56:58,787 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 16:56:59,817 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_05101_00001_nis_cal.fits>,).
2025-09-13 16:56:59,886 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 16:56:59,904 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 16:56:59,905 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 16:56:59,906 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 16:56:59,908 - jwst.combine_1d.combine1d - WARNING - 2 output pixel numbers were NaN
2025-09-13 16:56:59,908 - jwst.combine_1d.combine1d - WARNING - 46 elements of output had no corresponding input data;
2025-09-13 16:56:59,909 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 16:56:59,955 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 16:57:00,998 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faef3c8b4a0>,).
2025-09-13 16:57:00,999 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 16:57:02,052 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faef3c8b4a0>,).
2025-09-13 16:57:02,055 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 16:57:02,085 - jwst.extract_1d.extract - INFO - Working on slit 927
2025-09-13 16:57:02,086 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:57:02,087 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 43.00 (inclusive)
2025-09-13 16:57:02,141 - jwst.extract_1d.extract - INFO - Working on slit 927
2025-09-13 16:57:02,142 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:57:02,143 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 44.00 (inclusive)
2025-09-13 16:57:02,195 - jwst.extract_1d.extract - INFO - Working on slit 927
2025-09-13 16:57:02,196 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:57:02,197 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 43.00 (inclusive)
2025-09-13 16:57:02,338 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 16:57:03,407 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_05101_00001_nis_cal.fits>,).
2025-09-13 16:57:03,475 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 16:57:03,494 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 16:57:03,495 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 16:57:03,497 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 16:57:03,498 - jwst.combine_1d.combine1d - WARNING - 2 output pixel numbers were NaN
2025-09-13 16:57:03,499 - jwst.combine_1d.combine1d - WARNING - 53 elements of output had no corresponding input data;
2025-09-13 16:57:03,499 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 16:57:03,546 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 16:57:04,574 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faebe6e36e0>,).
2025-09-13 16:57:04,575 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 16:57:05,616 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faebe6e36e0>,).
2025-09-13 16:57:05,619 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 16:57:05,649 - jwst.extract_1d.extract - INFO - Working on slit 1417
2025-09-13 16:57:05,650 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:57:05,651 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 38.00 (inclusive)
2025-09-13 16:57:05,705 - jwst.extract_1d.extract - INFO - Working on slit 1417
2025-09-13 16:57:05,706 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:57:05,707 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 37.00 (inclusive)
2025-09-13 16:57:05,760 - jwst.extract_1d.extract - INFO - Working on slit 1417
2025-09-13 16:57:05,762 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:57:05,762 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 38.00 (inclusive)
2025-09-13 16:57:05,908 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 16:57:06,980 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_05101_00001_nis_cal.fits>,).
2025-09-13 16:57:07,052 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 16:57:07,070 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 16:57:07,071 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 16:57:07,073 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 16:57:07,074 - jwst.combine_1d.combine1d - WARNING - 2 output pixel numbers were NaN
2025-09-13 16:57:07,074 - jwst.combine_1d.combine1d - WARNING - 39 elements of output had no corresponding input data;
2025-09-13 16:57:07,075 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 16:57:07,123 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 16:57:08,216 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faebe6e2570>,).
2025-09-13 16:57:08,216 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 16:57:09,269 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faebe6e2570>,).
2025-09-13 16:57:09,273 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 16:57:09,302 - jwst.extract_1d.extract - INFO - Working on slit 567
2025-09-13 16:57:09,303 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:57:09,304 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 48.00 (inclusive)
2025-09-13 16:57:09,358 - jwst.extract_1d.extract - INFO - Working on slit 567
2025-09-13 16:57:09,359 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:57:09,360 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 48.00 (inclusive)
2025-09-13 16:57:09,412 - jwst.extract_1d.extract - INFO - Working on slit 567
2025-09-13 16:57:09,413 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:57:09,414 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 48.00 (inclusive)
2025-09-13 16:57:09,556 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 16:57:10,598 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_05101_00001_nis_cal.fits>,).
2025-09-13 16:57:10,665 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 16:57:10,683 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 16:57:10,684 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 16:57:10,685 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 16:57:10,687 - jwst.combine_1d.combine1d - WARNING - 3 output pixel numbers were NaN
2025-09-13 16:57:10,687 - jwst.combine_1d.combine1d - WARNING - 46 elements of output had no corresponding input data;
2025-09-13 16:57:10,688 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 16:57:10,734 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 16:57:11,732 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faebe6e0290>,).
2025-09-13 16:57:11,733 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 16:57:12,736 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faebe6e0290>,).
2025-09-13 16:57:12,739 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 16:57:12,768 - jwst.extract_1d.extract - INFO - Working on slit 1296
2025-09-13 16:57:12,769 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:57:12,770 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 42.00 (inclusive)
2025-09-13 16:57:12,822 - jwst.extract_1d.extract - INFO - Working on slit 1296
2025-09-13 16:57:12,824 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:57:12,824 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 43.00 (inclusive)
2025-09-13 16:57:12,876 - jwst.extract_1d.extract - INFO - Working on slit 1296
2025-09-13 16:57:12,877 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:57:12,878 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 42.00 (inclusive)
2025-09-13 16:57:13,018 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 16:57:14,056 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_05101_00001_nis_cal.fits>,).
2025-09-13 16:57:14,124 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 16:57:14,142 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 16:57:14,144 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 16:57:14,145 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 16:57:14,146 - jwst.combine_1d.combine1d - WARNING - 3 output pixel numbers were NaN
2025-09-13 16:57:14,146 - jwst.combine_1d.combine1d - WARNING - 43 elements of output had no corresponding input data;
2025-09-13 16:57:14,147 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 16:57:14,193 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 16:57:15,240 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faebe6e3ec0>,).
2025-09-13 16:57:15,241 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 16:57:16,254 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faebe6e3ec0>,).
2025-09-13 16:57:16,257 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 16:57:16,287 - jwst.extract_1d.extract - INFO - Working on slit 1412
2025-09-13 16:57:16,288 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:57:16,289 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 38.00 (inclusive)
2025-09-13 16:57:16,340 - jwst.extract_1d.extract - INFO - Working on slit 1412
2025-09-13 16:57:16,341 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:57:16,342 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 39.00 (inclusive)
2025-09-13 16:57:16,393 - jwst.extract_1d.extract - INFO - Working on slit 1412
2025-09-13 16:57:16,394 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:57:16,395 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 38.00 (inclusive)
2025-09-13 16:57:16,534 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 16:57:17,541 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_05101_00001_nis_cal.fits>,).
2025-09-13 16:57:17,609 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 16:57:17,626 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 16:57:17,627 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 16:57:17,628 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 16:57:17,629 - jwst.combine_1d.combine1d - WARNING - 2 output pixel numbers were NaN
2025-09-13 16:57:17,630 - jwst.combine_1d.combine1d - WARNING - 40 elements of output had no corresponding input data;
2025-09-13 16:57:17,630 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 16:57:17,677 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 16:57:18,698 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faebe6e0d40>,).
2025-09-13 16:57:18,699 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 16:57:19,719 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faebe6e0d40>,).
2025-09-13 16:57:19,723 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 16:57:19,753 - jwst.extract_1d.extract - INFO - Working on slit 654
2025-09-13 16:57:19,754 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:57:19,755 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 59.00 (inclusive)
2025-09-13 16:57:19,808 - jwst.extract_1d.extract - INFO - Working on slit 654
2025-09-13 16:57:19,809 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:57:19,810 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 59.00 (inclusive)
2025-09-13 16:57:19,862 - jwst.extract_1d.extract - INFO - Working on slit 654
2025-09-13 16:57:19,863 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:57:19,864 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 59.00 (inclusive)
2025-09-13 16:57:20,006 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 16:57:21,035 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_05101_00001_nis_cal.fits>,).
2025-09-13 16:57:21,104 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 16:57:21,123 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 16:57:21,125 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 16:57:21,126 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 16:57:21,128 - jwst.combine_1d.combine1d - WARNING - 2 output pixel numbers were NaN
2025-09-13 16:57:21,129 - jwst.combine_1d.combine1d - WARNING - 66 elements of output had no corresponding input data;
2025-09-13 16:57:21,129 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 16:57:21,176 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 16:57:22,232 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faebe6e2450>,).
2025-09-13 16:57:22,232 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 16:57:23,263 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faebe6e2450>,).
2025-09-13 16:57:23,267 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 16:57:23,296 - jwst.extract_1d.extract - INFO - Working on slit 1029
2025-09-13 16:57:23,297 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:57:23,298 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 56.00 (inclusive)
2025-09-13 16:57:23,350 - jwst.extract_1d.extract - INFO - Working on slit 1029
2025-09-13 16:57:23,352 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:57:23,353 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 56.00 (inclusive)
2025-09-13 16:57:23,404 - jwst.extract_1d.extract - INFO - Working on slit 1029
2025-09-13 16:57:23,405 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:57:23,406 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 55.00 (inclusive)
2025-09-13 16:57:23,547 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 16:57:24,551 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_05101_00001_nis_cal.fits>,).
2025-09-13 16:57:24,619 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 16:57:24,637 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 16:57:24,639 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 16:57:24,640 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 16:57:24,641 - jwst.combine_1d.combine1d - WARNING - 1 output pixel numbers were NaN
2025-09-13 16:57:24,641 - jwst.combine_1d.combine1d - WARNING - 75 elements of output had no corresponding input data;
2025-09-13 16:57:24,642 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 16:57:24,688 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 16:57:25,711 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faebe6e3770>,).
2025-09-13 16:57:25,711 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 16:57:26,720 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faebe6e3770>,).
2025-09-13 16:57:26,723 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 16:57:26,753 - jwst.extract_1d.extract - INFO - Working on slit 553
2025-09-13 16:57:26,754 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:57:26,755 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 34.00 (inclusive)
2025-09-13 16:57:26,807 - jwst.extract_1d.extract - INFO - Working on slit 553
2025-09-13 16:57:26,808 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:57:26,809 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 35.00 (inclusive)
2025-09-13 16:57:26,860 - jwst.extract_1d.extract - INFO - Working on slit 553
2025-09-13 16:57:26,861 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:57:26,862 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 35.00 (inclusive)
2025-09-13 16:57:27,002 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 16:57:28,014 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_05101_00001_nis_cal.fits>,).
2025-09-13 16:57:28,082 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 16:57:28,100 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 16:57:28,102 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 16:57:28,103 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 16:57:28,104 - jwst.combine_1d.combine1d - WARNING - 2 output pixel numbers were NaN
2025-09-13 16:57:28,105 - jwst.combine_1d.combine1d - WARNING - 48 elements of output had no corresponding input data;
2025-09-13 16:57:28,105 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 16:57:28,152 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 16:57:29,206 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faebe6e07a0>,).
2025-09-13 16:57:29,207 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 16:57:30,264 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faebe6e07a0>,).
2025-09-13 16:57:30,267 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 16:57:30,296 - jwst.extract_1d.extract - INFO - Working on slit 1387
2025-09-13 16:57:30,297 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:57:30,298 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 40.00 (inclusive)
2025-09-13 16:57:30,351 - jwst.extract_1d.extract - INFO - Working on slit 1387
2025-09-13 16:57:30,352 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:57:30,352 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 40.00 (inclusive)
2025-09-13 16:57:30,404 - jwst.extract_1d.extract - INFO - Working on slit 1387
2025-09-13 16:57:30,405 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:57:30,405 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 40.00 (inclusive)
2025-09-13 16:57:30,546 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 16:57:31,541 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_05101_00001_nis_cal.fits>,).
2025-09-13 16:57:31,609 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 16:57:31,626 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 16:57:31,627 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 16:57:31,628 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 16:57:31,629 - jwst.combine_1d.combine1d - WARNING - 3 output pixel numbers were NaN
2025-09-13 16:57:31,630 - jwst.combine_1d.combine1d - WARNING - 38 elements of output had no corresponding input data;
2025-09-13 16:57:31,630 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 16:57:31,677 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 16:57:32,695 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faee83d74a0>,).
2025-09-13 16:57:32,696 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 16:57:33,689 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faee83d74a0>,).
2025-09-13 16:57:33,692 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 16:57:33,722 - jwst.extract_1d.extract - INFO - Working on slit 422
2025-09-13 16:57:33,723 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:57:33,723 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 28.00 (inclusive)
2025-09-13 16:57:33,775 - jwst.extract_1d.extract - INFO - Working on slit 422
2025-09-13 16:57:33,776 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:57:33,777 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 28.00 (inclusive)
2025-09-13 16:57:33,828 - jwst.extract_1d.extract - INFO - Working on slit 422
2025-09-13 16:57:33,829 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:57:33,830 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 28.00 (inclusive)
2025-09-13 16:57:33,970 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 16:57:34,967 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_05101_00001_nis_cal.fits>,).
2025-09-13 16:57:35,035 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 16:57:35,052 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 16:57:35,054 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 16:57:35,055 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 16:57:35,056 - jwst.combine_1d.combine1d - WARNING - 3 output pixel numbers were NaN
2025-09-13 16:57:35,057 - jwst.combine_1d.combine1d - WARNING - 33 elements of output had no corresponding input data;
2025-09-13 16:57:35,057 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 16:57:35,104 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 16:57:36,174 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faee83d7770>,).
2025-09-13 16:57:36,175 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 16:57:37,219 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faee83d7770>,).
2025-09-13 16:57:37,222 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 16:57:37,251 - jwst.extract_1d.extract - INFO - Working on slit 821
2025-09-13 16:57:37,252 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:57:37,253 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 43.00 (inclusive)
2025-09-13 16:57:37,305 - jwst.extract_1d.extract - INFO - Working on slit 821
2025-09-13 16:57:37,306 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:57:37,307 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 42.00 (inclusive)
2025-09-13 16:57:37,359 - jwst.extract_1d.extract - INFO - Working on slit 821
2025-09-13 16:57:37,360 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:57:37,360 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 42.00 (inclusive)
2025-09-13 16:57:37,505 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 16:57:38,503 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_05101_00001_nis_cal.fits>,).
2025-09-13 16:57:38,571 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 16:57:38,587 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 16:57:38,589 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 16:57:38,590 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 16:57:38,591 - jwst.combine_1d.combine1d - WARNING - 1 output pixel numbers were NaN
2025-09-13 16:57:38,591 - jwst.combine_1d.combine1d - WARNING - 35 elements of output had no corresponding input data;
2025-09-13 16:57:38,591 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 16:57:38,638 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 16:57:39,636 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faee83d6f90>,).
2025-09-13 16:57:39,636 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 16:57:40,632 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faee83d6f90>,).
2025-09-13 16:57:40,635 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 16:57:40,664 - jwst.extract_1d.extract - INFO - Working on slit 682
2025-09-13 16:57:40,665 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:57:40,666 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 49.00 (inclusive)
2025-09-13 16:57:40,718 - jwst.extract_1d.extract - INFO - Working on slit 682
2025-09-13 16:57:40,719 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:57:40,719 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 50.00 (inclusive)
2025-09-13 16:57:40,770 - jwst.extract_1d.extract - INFO - Working on slit 682
2025-09-13 16:57:40,771 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:57:40,772 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 49.00 (inclusive)
2025-09-13 16:57:40,912 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 16:57:41,906 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_05101_00001_nis_cal.fits>,).
2025-09-13 16:57:41,973 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 16:57:41,990 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 16:57:41,991 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 16:57:41,992 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 16:57:41,994 - jwst.combine_1d.combine1d - WARNING - 3 output pixel numbers were NaN
2025-09-13 16:57:41,994 - jwst.combine_1d.combine1d - WARNING - 43 elements of output had no corresponding input data;
2025-09-13 16:57:41,994 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 16:57:42,040 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 16:57:43,058 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faee83d7380>,).
2025-09-13 16:57:43,059 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 16:57:44,091 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faee83d7380>,).
2025-09-13 16:57:44,094 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 16:57:44,124 - jwst.extract_1d.extract - INFO - Working on slit 1140
2025-09-13 16:57:44,125 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:57:44,126 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 41.00 (inclusive)
2025-09-13 16:57:44,178 - jwst.extract_1d.extract - INFO - Working on slit 1140
2025-09-13 16:57:44,179 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:57:44,180 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 42.00 (inclusive)
2025-09-13 16:57:44,232 - jwst.extract_1d.extract - INFO - Working on slit 1140
2025-09-13 16:57:44,233 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:57:44,234 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 42.00 (inclusive)
2025-09-13 16:57:44,376 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 16:57:45,391 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_05101_00001_nis_cal.fits>,).
2025-09-13 16:57:45,458 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 16:57:45,475 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 16:57:45,477 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 16:57:45,478 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 16:57:45,479 - jwst.combine_1d.combine1d - WARNING - 2 output pixel numbers were NaN
2025-09-13 16:57:45,479 - jwst.combine_1d.combine1d - WARNING - 48 elements of output had no corresponding input data;
2025-09-13 16:57:45,480 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 16:57:45,526 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 16:57:46,515 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faee83d6f00>,).
2025-09-13 16:57:46,516 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 16:57:47,504 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faee83d6f00>,).
2025-09-13 16:57:47,508 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 16:57:47,537 - jwst.extract_1d.extract - INFO - Working on slit 1388
2025-09-13 16:57:47,538 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:57:47,539 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 58.00 (inclusive)
2025-09-13 16:57:47,591 - jwst.extract_1d.extract - INFO - Working on slit 1388
2025-09-13 16:57:47,592 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:57:47,593 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 58.00 (inclusive)
2025-09-13 16:57:47,644 - jwst.extract_1d.extract - INFO - Working on slit 1388
2025-09-13 16:57:47,645 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:57:47,646 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 58.00 (inclusive)
2025-09-13 16:57:47,786 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 16:57:48,766 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_05101_00001_nis_cal.fits>,).
2025-09-13 16:57:48,832 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 16:57:48,850 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 16:57:48,851 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 16:57:48,852 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 16:57:48,854 - jwst.combine_1d.combine1d - WARNING - 2 output pixel numbers were NaN
2025-09-13 16:57:48,854 - jwst.combine_1d.combine1d - WARNING - 51 elements of output had no corresponding input data;
2025-09-13 16:57:48,855 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 16:57:48,901 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 16:57:49,936 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faee83d60f0>,).
2025-09-13 16:57:49,936 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 16:57:50,985 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faee83d60f0>,).
2025-09-13 16:57:50,988 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 16:57:51,018 - jwst.extract_1d.extract - INFO - Working on slit 759
2025-09-13 16:57:51,019 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:57:51,020 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 40.00 (inclusive)
2025-09-13 16:57:51,073 - jwst.extract_1d.extract - INFO - Working on slit 759
2025-09-13 16:57:51,074 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:57:51,075 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 40.00 (inclusive)
2025-09-13 16:57:51,127 - jwst.extract_1d.extract - INFO - Working on slit 759
2025-09-13 16:57:51,128 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:57:51,129 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 39.00 (inclusive)
2025-09-13 16:57:51,273 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 16:57:52,295 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_05101_00001_nis_cal.fits>,).
2025-09-13 16:57:52,362 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 16:57:52,380 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 16:57:52,382 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 16:57:52,383 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 16:57:52,384 - jwst.combine_1d.combine1d - WARNING - 2 output pixel numbers were NaN
2025-09-13 16:57:52,385 - jwst.combine_1d.combine1d - WARNING - 45 elements of output had no corresponding input data;
2025-09-13 16:57:52,385 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 16:57:52,432 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 16:57:53,454 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faebcc584d0>,).
2025-09-13 16:57:53,455 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 16:57:54,471 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faebcc584d0>,).
2025-09-13 16:57:54,475 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 16:57:54,504 - jwst.extract_1d.extract - INFO - Working on slit 1407
2025-09-13 16:57:54,505 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:57:54,506 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 34.00 (inclusive)
2025-09-13 16:57:54,558 - jwst.extract_1d.extract - INFO - Working on slit 1407
2025-09-13 16:57:54,559 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:57:54,560 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 35.00 (inclusive)
2025-09-13 16:57:54,611 - jwst.extract_1d.extract - INFO - Working on slit 1407
2025-09-13 16:57:54,612 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:57:54,613 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 35.00 (inclusive)
2025-09-13 16:57:54,753 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 16:57:55,771 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_05101_00001_nis_cal.fits>,).
2025-09-13 16:57:55,839 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 16:57:55,857 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 16:57:55,858 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 16:57:55,859 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 16:57:55,861 - jwst.combine_1d.combine1d - WARNING - 3 output pixel numbers were NaN
2025-09-13 16:57:55,861 - jwst.combine_1d.combine1d - WARNING - 42 elements of output had no corresponding input data;
2025-09-13 16:57:55,861 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 16:57:55,908 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 16:57:56,922 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faebcc58320>,).
2025-09-13 16:57:56,923 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 16:57:57,973 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faebcc58320>,).
2025-09-13 16:57:57,976 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 16:57:58,005 - jwst.extract_1d.extract - INFO - Working on slit 1194
2025-09-13 16:57:58,006 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:57:58,007 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 28.00 (inclusive)
2025-09-13 16:57:58,060 - jwst.extract_1d.extract - INFO - Working on slit 1194
2025-09-13 16:57:58,061 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:57:58,062 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 29.00 (inclusive)
2025-09-13 16:57:58,114 - jwst.extract_1d.extract - INFO - Working on slit 1194
2025-09-13 16:57:58,115 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:57:58,116 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 29.00 (inclusive)
2025-09-13 16:57:58,257 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 16:57:59,288 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_05101_00001_nis_cal.fits>,).
2025-09-13 16:57:59,357 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 16:57:59,375 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 16:57:59,377 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 16:57:59,378 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 16:57:59,379 - jwst.combine_1d.combine1d - WARNING - 2 output pixel numbers were NaN
2025-09-13 16:57:59,379 - jwst.combine_1d.combine1d - WARNING - 42 elements of output had no corresponding input data;
2025-09-13 16:57:59,380 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 16:57:59,428 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 16:58:00,465 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faebcc58560>,).
2025-09-13 16:58:00,466 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 16:58:01,479 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faebcc58560>,).
2025-09-13 16:58:01,482 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 16:58:01,512 - jwst.extract_1d.extract - INFO - Working on slit 712
2025-09-13 16:58:01,513 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:58:01,514 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 34.00 (inclusive)
2025-09-13 16:58:01,567 - jwst.extract_1d.extract - INFO - Working on slit 712
2025-09-13 16:58:01,568 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:58:01,569 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 34.00 (inclusive)
2025-09-13 16:58:01,620 - jwst.extract_1d.extract - INFO - Working on slit 712
2025-09-13 16:58:01,621 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:58:01,622 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 33.00 (inclusive)
2025-09-13 16:58:01,762 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 16:58:02,769 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_05101_00001_nis_cal.fits>,).
2025-09-13 16:58:02,837 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 16:58:02,855 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 16:58:02,856 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 16:58:02,857 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 16:58:02,858 - jwst.combine_1d.combine1d - WARNING - 3 output pixel numbers were NaN
2025-09-13 16:58:02,859 - jwst.combine_1d.combine1d - WARNING - 41 elements of output had no corresponding input data;
2025-09-13 16:58:02,859 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 16:58:02,906 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 16:58:03,931 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faebcc5b380>,).
2025-09-13 16:58:03,932 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 16:58:04,975 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faebcc5b380>,).
2025-09-13 16:58:04,979 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 16:58:05,008 - jwst.extract_1d.extract - INFO - Working on slit 539
2025-09-13 16:58:05,009 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:58:05,010 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 42.00 (inclusive)
2025-09-13 16:58:05,063 - jwst.extract_1d.extract - INFO - Working on slit 539
2025-09-13 16:58:05,064 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:58:05,065 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 42.00 (inclusive)
2025-09-13 16:58:05,117 - jwst.extract_1d.extract - INFO - Working on slit 539
2025-09-13 16:58:05,118 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:58:05,119 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 42.00 (inclusive)
2025-09-13 16:58:05,261 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 16:58:06,297 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_05101_00001_nis_cal.fits>,).
2025-09-13 16:58:06,364 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 16:58:06,381 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 16:58:06,383 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 16:58:06,384 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 16:58:06,385 - jwst.combine_1d.combine1d - WARNING - 3 output pixel numbers were NaN
2025-09-13 16:58:06,385 - jwst.combine_1d.combine1d - WARNING - 28 elements of output had no corresponding input data;
2025-09-13 16:58:06,386 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 16:58:06,433 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 16:58:07,458 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faebcc59370>,).
2025-09-13 16:58:07,459 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 16:58:08,466 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faebcc59370>,).
2025-09-13 16:58:08,469 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 16:58:08,498 - jwst.extract_1d.extract - INFO - Working on slit 1008
2025-09-13 16:58:08,499 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:58:08,500 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 31.00 (inclusive)
2025-09-13 16:58:08,552 - jwst.extract_1d.extract - INFO - Working on slit 1008
2025-09-13 16:58:08,554 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:58:08,554 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 30.00 (inclusive)
2025-09-13 16:58:08,604 - jwst.extract_1d.extract - INFO - Working on slit 1008
2025-09-13 16:58:08,605 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:58:08,606 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 30.00 (inclusive)
2025-09-13 16:58:08,745 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 16:58:09,736 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_05101_00001_nis_cal.fits>,).
2025-09-13 16:58:09,803 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 16:58:09,819 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 16:58:09,820 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 16:58:09,822 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 16:58:09,823 - jwst.combine_1d.combine1d - WARNING - 2 output pixel numbers were NaN
2025-09-13 16:58:09,823 - jwst.combine_1d.combine1d - WARNING - 33 elements of output had no corresponding input data;
2025-09-13 16:58:09,824 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 16:58:09,870 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 16:58:10,865 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faebcc58950>,).
2025-09-13 16:58:10,866 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 16:58:11,907 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faebcc58950>,).
2025-09-13 16:58:11,910 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 16:58:11,940 - jwst.extract_1d.extract - INFO - Working on slit 347
2025-09-13 16:58:11,941 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type POINT
2025-09-13 16:58:11,942 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 10.00 (inclusive)
2025-09-13 16:58:11,949 - jwst.extract_1d.extract - INFO - Creating aperture correction.
2025-09-13 16:58:12,070 - jwst.extract_1d.extract - INFO - Working on slit 347
2025-09-13 16:58:12,071 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type POINT
2025-09-13 16:58:12,072 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 10.00 (inclusive)
2025-09-13 16:58:12,079 - jwst.extract_1d.extract - INFO - Creating aperture correction.
2025-09-13 16:58:12,202 - jwst.extract_1d.extract - INFO - Working on slit 347
2025-09-13 16:58:12,203 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type POINT
2025-09-13 16:58:12,204 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 10.00 (inclusive)
2025-09-13 16:58:12,211 - jwst.extract_1d.extract - INFO - Creating aperture correction.
2025-09-13 16:58:12,425 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 16:58:13,460 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_05101_00001_nis_cal.fits>,).
2025-09-13 16:58:13,527 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 16:58:13,544 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 16:58:13,545 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 16:58:13,546 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 16:58:13,547 - jwst.combine_1d.combine1d - WARNING - 3 output pixel numbers were NaN
2025-09-13 16:58:13,548 - jwst.combine_1d.combine1d - WARNING - 33 elements of output had no corresponding input data;
2025-09-13 16:58:13,548 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 16:58:13,594 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 16:58:14,581 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faebcc5b770>,).
2025-09-13 16:58:14,582 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 16:58:15,585 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faebcc5b770>,).
2025-09-13 16:58:15,588 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 16:58:15,617 - jwst.extract_1d.extract - INFO - Working on slit 276
2025-09-13 16:58:15,618 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:58:15,619 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 44.00 (inclusive)
2025-09-13 16:58:15,670 - jwst.extract_1d.extract - INFO - Working on slit 276
2025-09-13 16:58:15,671 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:58:15,672 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 44.00 (inclusive)
2025-09-13 16:58:15,723 - jwst.extract_1d.extract - INFO - Working on slit 276
2025-09-13 16:58:15,724 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:58:15,725 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 44.00 (inclusive)
2025-09-13 16:58:15,866 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 16:58:16,870 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_05101_00001_nis_cal.fits>,).
2025-09-13 16:58:16,937 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 16:58:16,954 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 16:58:16,956 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 16:58:16,957 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 16:58:16,958 - jwst.combine_1d.combine1d - WARNING - 2 output pixel numbers were NaN
2025-09-13 16:58:16,958 - jwst.combine_1d.combine1d - WARNING - 43 elements of output had no corresponding input data;
2025-09-13 16:58:16,958 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 16:58:17,005 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 16:58:17,997 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faebcc59d90>,).
2025-09-13 16:58:17,998 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 16:58:19,046 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faebcc59d90>,).
2025-09-13 16:58:19,049 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 16:58:19,079 - jwst.extract_1d.extract - INFO - Working on slit 605
2025-09-13 16:58:19,080 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type POINT
2025-09-13 16:58:19,081 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 10.00 (inclusive)
2025-09-13 16:58:19,088 - jwst.extract_1d.extract - INFO - Creating aperture correction.
2025-09-13 16:58:19,207 - jwst.extract_1d.extract - INFO - Working on slit 605
2025-09-13 16:58:19,208 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type POINT
2025-09-13 16:58:19,208 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 10.00 (inclusive)
2025-09-13 16:58:19,215 - jwst.extract_1d.extract - INFO - Creating aperture correction.
2025-09-13 16:58:19,336 - jwst.extract_1d.extract - INFO - Working on slit 605
2025-09-13 16:58:19,337 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type POINT
2025-09-13 16:58:19,338 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 10.00 (inclusive)
2025-09-13 16:58:19,344 - jwst.extract_1d.extract - INFO - Creating aperture correction.
2025-09-13 16:58:19,556 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 16:58:20,610 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_05101_00001_nis_cal.fits>,).
2025-09-13 16:58:20,678 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 16:58:20,694 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 16:58:20,695 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 16:58:20,696 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 16:58:20,698 - jwst.combine_1d.combine1d - WARNING - 3 output pixel numbers were NaN
2025-09-13 16:58:20,698 - jwst.combine_1d.combine1d - WARNING - 25 elements of output had no corresponding input data;
2025-09-13 16:58:20,698 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 16:58:20,745 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 16:58:21,770 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faebcc5a720>,).
2025-09-13 16:58:21,771 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 16:58:22,790 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faebcc5a720>,).
2025-09-13 16:58:22,793 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 16:58:22,823 - jwst.extract_1d.extract - INFO - Working on slit 922
2025-09-13 16:58:22,824 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:58:22,825 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 30.00 (inclusive)
2025-09-13 16:58:22,877 - jwst.extract_1d.extract - INFO - Working on slit 922
2025-09-13 16:58:22,878 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:58:22,878 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 29.00 (inclusive)
2025-09-13 16:58:22,930 - jwst.extract_1d.extract - INFO - Working on slit 922
2025-09-13 16:58:22,931 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:58:22,931 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 30.00 (inclusive)
2025-09-13 16:58:23,071 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 16:58:24,094 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_05101_00001_nis_cal.fits>,).
2025-09-13 16:58:24,161 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 16:58:24,178 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 16:58:24,179 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 16:58:24,181 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 16:58:24,182 - jwst.combine_1d.combine1d - WARNING - 3 output pixel numbers were NaN
2025-09-13 16:58:24,182 - jwst.combine_1d.combine1d - WARNING - 31 elements of output had no corresponding input data;
2025-09-13 16:58:24,183 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 16:58:24,229 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 16:58:25,259 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faebcc5aba0>,).
2025-09-13 16:58:25,259 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 16:58:26,355 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faebcc5aba0>,).
2025-09-13 16:58:26,359 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 16:58:26,389 - jwst.extract_1d.extract - INFO - Working on slit 736
2025-09-13 16:58:26,390 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:58:26,391 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 22.00 (inclusive)
2025-09-13 16:58:26,444 - jwst.extract_1d.extract - INFO - Working on slit 736
2025-09-13 16:58:26,445 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:58:26,446 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 22.00 (inclusive)
2025-09-13 16:58:26,498 - jwst.extract_1d.extract - INFO - Working on slit 736
2025-09-13 16:58:26,499 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:58:26,500 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 23.00 (inclusive)
2025-09-13 16:58:26,650 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 16:58:27,740 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_05101_00001_nis_cal.fits>,).
2025-09-13 16:58:27,808 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 16:58:27,824 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 16:58:27,825 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 16:58:27,826 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 16:58:27,827 - jwst.combine_1d.combine1d - WARNING - 1 output pixel numbers were NaN
2025-09-13 16:58:27,828 - jwst.combine_1d.combine1d - WARNING - 20 elements of output had no corresponding input data;
2025-09-13 16:58:27,828 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 16:58:27,876 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 16:58:28,910 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faebcc58ef0>,).
2025-09-13 16:58:28,911 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 16:58:29,941 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faebcc58ef0>,).
2025-09-13 16:58:29,945 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 16:58:29,974 - jwst.extract_1d.extract - INFO - Working on slit 1423
2025-09-13 16:58:29,975 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:58:29,976 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 31.00 (inclusive)
2025-09-13 16:58:30,028 - jwst.extract_1d.extract - INFO - Working on slit 1423
2025-09-13 16:58:30,029 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:58:30,029 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 31.00 (inclusive)
2025-09-13 16:58:30,080 - jwst.extract_1d.extract - INFO - Working on slit 1423
2025-09-13 16:58:30,081 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:58:30,082 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 31.00 (inclusive)
2025-09-13 16:58:30,224 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 16:58:31,266 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_05101_00001_nis_cal.fits>,).
2025-09-13 16:58:31,336 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 16:58:31,354 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 16:58:31,355 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 16:58:31,356 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 16:58:31,357 - jwst.combine_1d.combine1d - WARNING - 2 output pixel numbers were NaN
2025-09-13 16:58:31,358 - jwst.combine_1d.combine1d - WARNING - 34 elements of output had no corresponding input data;
2025-09-13 16:58:31,358 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 16:58:31,407 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 16:58:32,478 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faebcc583b0>,).
2025-09-13 16:58:32,478 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 16:58:33,572 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faebcc583b0>,).
2025-09-13 16:58:33,576 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 16:58:33,606 - jwst.extract_1d.extract - INFO - Working on slit 800
2025-09-13 16:58:33,608 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:58:33,608 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 26.00 (inclusive)
2025-09-13 16:58:33,662 - jwst.extract_1d.extract - INFO - Working on slit 800
2025-09-13 16:58:33,663 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:58:33,664 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 26.00 (inclusive)
2025-09-13 16:58:33,718 - jwst.extract_1d.extract - INFO - Working on slit 800
2025-09-13 16:58:33,720 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:58:33,720 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 26.00 (inclusive)
2025-09-13 16:58:33,868 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 16:58:34,972 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_05101_00001_nis_cal.fits>,).
2025-09-13 16:58:35,039 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 16:58:35,056 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 16:58:35,057 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 16:58:35,058 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 16:58:35,059 - jwst.combine_1d.combine1d - WARNING - 3 output pixel numbers were NaN
2025-09-13 16:58:35,060 - jwst.combine_1d.combine1d - WARNING - 28 elements of output had no corresponding input data;
2025-09-13 16:58:35,060 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 16:58:35,106 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 16:58:36,142 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faee4029130>,).
2025-09-13 16:58:36,143 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 16:58:37,177 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faee4029130>,).
2025-09-13 16:58:37,181 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 16:58:37,211 - jwst.extract_1d.extract - INFO - Working on slit 873
2025-09-13 16:58:37,212 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:58:37,212 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 27.00 (inclusive)
2025-09-13 16:58:37,265 - jwst.extract_1d.extract - INFO - Working on slit 873
2025-09-13 16:58:37,266 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:58:37,267 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 27.00 (inclusive)
2025-09-13 16:58:37,319 - jwst.extract_1d.extract - INFO - Working on slit 873
2025-09-13 16:58:37,320 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:58:37,321 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 27.00 (inclusive)
2025-09-13 16:58:37,462 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 16:58:38,506 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_05101_00001_nis_cal.fits>,).
2025-09-13 16:58:38,575 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 16:58:38,592 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 16:58:38,593 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 16:58:38,594 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 16:58:38,596 - jwst.combine_1d.combine1d - WARNING - 3 output pixel numbers were NaN
2025-09-13 16:58:38,596 - jwst.combine_1d.combine1d - WARNING - 22 elements of output had no corresponding input data;
2025-09-13 16:58:38,597 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 16:58:38,644 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 16:58:39,696 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faee402a9f0>,).
2025-09-13 16:58:39,696 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 16:58:40,823 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faee402a9f0>,).
2025-09-13 16:58:40,826 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 16:58:40,856 - jwst.extract_1d.extract - INFO - Working on slit 385
2025-09-13 16:58:40,857 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:58:40,858 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 21.00 (inclusive)
2025-09-13 16:58:40,911 - jwst.extract_1d.extract - INFO - Working on slit 385
2025-09-13 16:58:40,912 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:58:40,913 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 20.00 (inclusive)
2025-09-13 16:58:40,965 - jwst.extract_1d.extract - INFO - Working on slit 385
2025-09-13 16:58:40,966 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:58:40,967 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 21.00 (inclusive)
2025-09-13 16:58:41,110 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 16:58:42,186 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_05101_00001_nis_cal.fits>,).
2025-09-13 16:58:42,254 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 16:58:42,271 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 16:58:42,272 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 16:58:42,273 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 16:58:42,274 - jwst.combine_1d.combine1d - WARNING - 3 output pixel numbers were NaN
2025-09-13 16:58:42,275 - jwst.combine_1d.combine1d - WARNING - 43 elements of output had no corresponding input data;
2025-09-13 16:58:42,275 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 16:58:42,323 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 16:58:43,352 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faee402b650>,).
2025-09-13 16:58:43,353 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 16:58:44,389 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faee402b650>,).
2025-09-13 16:58:44,392 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 16:58:44,422 - jwst.extract_1d.extract - INFO - Working on slit 557
2025-09-13 16:58:44,423 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:58:44,424 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 37.00 (inclusive)
2025-09-13 16:58:44,477 - jwst.extract_1d.extract - INFO - Working on slit 557
2025-09-13 16:58:44,478 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:58:44,479 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 37.00 (inclusive)
2025-09-13 16:58:44,531 - jwst.extract_1d.extract - INFO - Working on slit 557
2025-09-13 16:58:44,532 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:58:44,533 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 38.00 (inclusive)
2025-09-13 16:58:44,674 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 16:58:45,703 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_05101_00001_nis_cal.fits>,).
2025-09-13 16:58:45,771 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 16:58:45,788 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 16:58:45,789 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 16:58:45,790 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 16:58:45,791 - jwst.combine_1d.combine1d - WARNING - 3 output pixel numbers were NaN
2025-09-13 16:58:45,792 - jwst.combine_1d.combine1d - WARNING - 40 elements of output had no corresponding input data;
2025-09-13 16:58:45,792 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 16:58:45,839 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 16:58:46,880 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faee402b890>,).
2025-09-13 16:58:46,881 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 16:58:47,973 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faee402b890>,).
2025-09-13 16:58:47,976 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 16:58:48,006 - jwst.extract_1d.extract - INFO - Working on slit 719
2025-09-13 16:58:48,007 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:58:48,008 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 28.00 (inclusive)
2025-09-13 16:58:48,060 - jwst.extract_1d.extract - INFO - Working on slit 719
2025-09-13 16:58:48,061 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:58:48,062 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 29.00 (inclusive)
2025-09-13 16:58:48,114 - jwst.extract_1d.extract - INFO - Working on slit 719
2025-09-13 16:58:48,115 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:58:48,116 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 29.00 (inclusive)
2025-09-13 16:58:48,258 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 16:58:49,321 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_05101_00001_nis_cal.fits>,).
2025-09-13 16:58:49,388 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 16:58:49,404 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 16:58:49,406 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 16:58:49,407 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 16:58:49,408 - jwst.combine_1d.combine1d - WARNING - 3 output pixel numbers were NaN
2025-09-13 16:58:49,408 - jwst.combine_1d.combine1d - WARNING - 24 elements of output had no corresponding input data;
2025-09-13 16:58:49,409 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 16:58:49,454 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 16:58:50,466 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faee40285f0>,).
2025-09-13 16:58:50,467 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 16:58:51,481 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faee40285f0>,).
2025-09-13 16:58:51,484 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 16:58:51,513 - jwst.extract_1d.extract - INFO - Working on slit 389
2025-09-13 16:58:51,514 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:58:51,515 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 30.00 (inclusive)
2025-09-13 16:58:51,566 - jwst.extract_1d.extract - INFO - Working on slit 389
2025-09-13 16:58:51,568 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:58:51,568 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 30.00 (inclusive)
2025-09-13 16:58:51,619 - jwst.extract_1d.extract - INFO - Working on slit 389
2025-09-13 16:58:51,620 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:58:51,621 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 29.00 (inclusive)
2025-09-13 16:58:51,760 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 16:58:52,775 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_05101_00001_nis_cal.fits>,).
2025-09-13 16:58:52,841 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 16:58:52,858 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 16:58:52,860 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 16:58:52,861 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 16:58:52,862 - jwst.combine_1d.combine1d - WARNING - 3 output pixel numbers were NaN
2025-09-13 16:58:52,862 - jwst.combine_1d.combine1d - WARNING - 34 elements of output had no corresponding input data;
2025-09-13 16:58:52,863 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 16:58:52,909 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 16:58:53,926 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faee4029b50>,).
2025-09-13 16:58:53,926 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 16:58:54,959 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faee4029b50>,).
2025-09-13 16:58:54,962 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 16:58:54,992 - jwst.extract_1d.extract - INFO - Working on slit 733
2025-09-13 16:58:54,993 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:58:54,994 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 44.00 (inclusive)
2025-09-13 16:58:55,045 - jwst.extract_1d.extract - INFO - Working on slit 733
2025-09-13 16:58:55,046 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:58:55,047 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 43.00 (inclusive)
2025-09-13 16:58:55,098 - jwst.extract_1d.extract - INFO - Working on slit 733
2025-09-13 16:58:55,099 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:58:55,100 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 43.00 (inclusive)
2025-09-13 16:58:55,240 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 16:58:56,288 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_05101_00001_nis_cal.fits>,).
2025-09-13 16:58:56,355 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 16:58:56,373 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 16:58:56,374 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 16:58:56,375 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 16:58:56,376 - jwst.combine_1d.combine1d - WARNING - 2 output pixel numbers were NaN
2025-09-13 16:58:56,377 - jwst.combine_1d.combine1d - WARNING - 54 elements of output had no corresponding input data;
2025-09-13 16:58:56,377 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 16:58:56,423 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 16:58:57,424 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faee402b260>,).
2025-09-13 16:58:57,425 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 16:58:58,429 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faee402b260>,).
2025-09-13 16:58:58,432 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 16:58:58,461 - jwst.extract_1d.extract - INFO - Working on slit 1442
2025-09-13 16:58:58,462 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:58:58,463 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 44.00 (inclusive)
2025-09-13 16:58:58,514 - jwst.extract_1d.extract - INFO - Working on slit 1442
2025-09-13 16:58:58,515 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:58:58,516 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 43.00 (inclusive)
2025-09-13 16:58:58,567 - jwst.extract_1d.extract - INFO - Working on slit 1442
2025-09-13 16:58:58,568 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:58:58,569 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 43.00 (inclusive)
2025-09-13 16:58:58,709 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 16:58:59,710 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_05101_00001_nis_cal.fits>,).
2025-09-13 16:58:59,777 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 16:58:59,794 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 16:58:59,796 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 16:58:59,797 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 16:58:59,798 - jwst.combine_1d.combine1d - WARNING - 2 output pixel numbers were NaN
2025-09-13 16:58:59,799 - jwst.combine_1d.combine1d - WARNING - 44 elements of output had no corresponding input data;
2025-09-13 16:58:59,799 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 16:58:59,846 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 16:59:00,862 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faee402b770>,).
2025-09-13 16:59:00,863 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 16:59:01,902 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faee402b770>,).
2025-09-13 16:59:01,906 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 16:59:01,935 - jwst.extract_1d.extract - INFO - Working on slit 417
2025-09-13 16:59:01,936 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:59:01,937 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 28.00 (inclusive)
2025-09-13 16:59:01,990 - jwst.extract_1d.extract - INFO - Working on slit 417
2025-09-13 16:59:01,991 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:59:01,992 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 29.00 (inclusive)
2025-09-13 16:59:02,043 - jwst.extract_1d.extract - INFO - Working on slit 417
2025-09-13 16:59:02,044 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:59:02,045 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 28.00 (inclusive)
2025-09-13 16:59:02,189 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 16:59:03,254 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_05101_00001_nis_cal.fits>,).
2025-09-13 16:59:03,321 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 16:59:03,338 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 16:59:03,339 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 16:59:03,340 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 16:59:03,342 - jwst.combine_1d.combine1d - WARNING - 2 output pixel numbers were NaN
2025-09-13 16:59:03,342 - jwst.combine_1d.combine1d - WARNING - 27 elements of output had no corresponding input data;
2025-09-13 16:59:03,342 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 16:59:03,389 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 16:59:04,433 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faee40280e0>,).
2025-09-13 16:59:04,433 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 16:59:05,486 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faee40280e0>,).
2025-09-13 16:59:05,489 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 16:59:05,518 - jwst.extract_1d.extract - INFO - Working on slit 630
2025-09-13 16:59:05,519 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type POINT
2025-09-13 16:59:05,520 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 10.00 (inclusive)
2025-09-13 16:59:05,526 - jwst.extract_1d.extract - INFO - Creating aperture correction.
2025-09-13 16:59:05,641 - jwst.extract_1d.extract - INFO - Working on slit 630
2025-09-13 16:59:05,642 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type POINT
2025-09-13 16:59:05,643 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 10.00 (inclusive)
2025-09-13 16:59:05,649 - jwst.extract_1d.extract - INFO - Creating aperture correction.
2025-09-13 16:59:05,766 - jwst.extract_1d.extract - INFO - Working on slit 630
2025-09-13 16:59:05,767 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type POINT
2025-09-13 16:59:05,768 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 10.00 (inclusive)
2025-09-13 16:59:05,774 - jwst.extract_1d.extract - INFO - Creating aperture correction.
2025-09-13 16:59:05,979 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 16:59:07,003 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_05101_00001_nis_cal.fits>,).
2025-09-13 16:59:07,071 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 16:59:07,087 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 16:59:07,089 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 16:59:07,090 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 16:59:07,091 - jwst.combine_1d.combine1d - WARNING - 3 output pixel numbers were NaN
2025-09-13 16:59:07,091 - jwst.combine_1d.combine1d - WARNING - 20 elements of output had no corresponding input data;
2025-09-13 16:59:07,092 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 16:59:07,139 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 16:59:08,162 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faee402af00>,).
2025-09-13 16:59:08,163 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 16:59:09,225 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faee402af00>,).
2025-09-13 16:59:09,229 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 16:59:09,259 - jwst.extract_1d.extract - INFO - Working on slit 925
2025-09-13 16:59:09,260 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:59:09,261 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 32.00 (inclusive)
2025-09-13 16:59:09,315 - jwst.extract_1d.extract - INFO - Working on slit 925
2025-09-13 16:59:09,316 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:59:09,317 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 32.00 (inclusive)
2025-09-13 16:59:09,371 - jwst.extract_1d.extract - INFO - Working on slit 925
2025-09-13 16:59:09,372 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:59:09,373 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 33.00 (inclusive)
2025-09-13 16:59:09,517 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 16:59:10,581 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_05101_00001_nis_cal.fits>,).
2025-09-13 16:59:10,649 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 16:59:10,667 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 16:59:10,668 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 16:59:10,670 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 16:59:10,671 - jwst.combine_1d.combine1d - WARNING - 3 output pixel numbers were NaN
2025-09-13 16:59:10,671 - jwst.combine_1d.combine1d - WARNING - 43 elements of output had no corresponding input data;
2025-09-13 16:59:10,671 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 16:59:10,718 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 16:59:11,715 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faee402bc80>,).
2025-09-13 16:59:11,716 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 16:59:12,730 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faee402bc80>,).
2025-09-13 16:59:12,733 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 16:59:12,762 - jwst.extract_1d.extract - INFO - Working on slit 527
2025-09-13 16:59:12,763 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:59:12,764 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 35.00 (inclusive)
2025-09-13 16:59:12,815 - jwst.extract_1d.extract - INFO - Working on slit 527
2025-09-13 16:59:12,816 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:59:12,817 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 35.00 (inclusive)
2025-09-13 16:59:12,868 - jwst.extract_1d.extract - INFO - Working on slit 527
2025-09-13 16:59:12,869 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:59:12,870 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 35.00 (inclusive)
2025-09-13 16:59:13,010 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 16:59:14,030 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_05101_00001_nis_cal.fits>,).
2025-09-13 16:59:14,097 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 16:59:14,114 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 16:59:14,115 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 16:59:14,116 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 16:59:14,117 - jwst.combine_1d.combine1d - WARNING - 2 output pixel numbers were NaN
2025-09-13 16:59:14,118 - jwst.combine_1d.combine1d - WARNING - 29 elements of output had no corresponding input data;
2025-09-13 16:59:14,118 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 16:59:14,163 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 16:59:15,169 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faee4028dd0>,).
2025-09-13 16:59:15,170 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 16:59:16,200 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faee4028dd0>,).
2025-09-13 16:59:16,203 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 16:59:16,232 - jwst.extract_1d.extract - INFO - Working on slit 439
2025-09-13 16:59:16,233 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type POINT
2025-09-13 16:59:16,234 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 10.00 (inclusive)
2025-09-13 16:59:16,241 - jwst.extract_1d.extract - INFO - Creating aperture correction.
2025-09-13 16:59:16,365 - jwst.extract_1d.extract - INFO - Working on slit 439
2025-09-13 16:59:16,366 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type POINT
2025-09-13 16:59:16,367 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 10.00 (inclusive)
2025-09-13 16:59:16,373 - jwst.extract_1d.extract - INFO - Creating aperture correction.
2025-09-13 16:59:16,499 - jwst.extract_1d.extract - INFO - Working on slit 439
2025-09-13 16:59:16,500 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type POINT
2025-09-13 16:59:16,501 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 10.00 (inclusive)
2025-09-13 16:59:16,507 - jwst.extract_1d.extract - INFO - Creating aperture correction.
2025-09-13 16:59:16,725 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 16:59:17,784 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_05101_00001_nis_cal.fits>,).
2025-09-13 16:59:17,853 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 16:59:17,871 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 16:59:17,872 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 16:59:17,873 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 16:59:17,875 - jwst.combine_1d.combine1d - WARNING - 3 output pixel numbers were NaN
2025-09-13 16:59:17,875 - jwst.combine_1d.combine1d - WARNING - 39 elements of output had no corresponding input data;
2025-09-13 16:59:17,876 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 16:59:17,923 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 16:59:18,948 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faef738e960>,).
2025-09-13 16:59:18,949 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 16:59:19,960 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faef738e960>,).
2025-09-13 16:59:19,964 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 16:59:19,993 - jwst.extract_1d.extract - INFO - Working on slit 1253
2025-09-13 16:59:19,994 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:59:19,995 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 33.00 (inclusive)
2025-09-13 16:59:20,046 - jwst.extract_1d.extract - INFO - Working on slit 1253
2025-09-13 16:59:20,047 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:59:20,048 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 32.00 (inclusive)
2025-09-13 16:59:20,098 - jwst.extract_1d.extract - INFO - Working on slit 1253
2025-09-13 16:59:20,099 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:59:20,100 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 32.00 (inclusive)
2025-09-13 16:59:20,238 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 16:59:21,258 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_05101_00001_nis_cal.fits>,).
2025-09-13 16:59:21,325 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 16:59:21,341 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 16:59:21,343 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 16:59:21,344 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 16:59:21,345 - jwst.combine_1d.combine1d - WARNING - 2 output pixel numbers were NaN
2025-09-13 16:59:21,345 - jwst.combine_1d.combine1d - WARNING - 25 elements of output had no corresponding input data;
2025-09-13 16:59:21,346 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 16:59:21,391 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 16:59:22,420 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faef738dd90>,).
2025-09-13 16:59:22,421 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 16:59:23,462 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faef738dd90>,).
2025-09-13 16:59:23,466 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 16:59:23,496 - jwst.extract_1d.extract - INFO - Working on slit 1162
2025-09-13 16:59:23,497 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:59:23,498 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 18.00 (inclusive)
2025-09-13 16:59:23,550 - jwst.extract_1d.extract - INFO - Working on slit 1162
2025-09-13 16:59:23,551 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:59:23,552 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 18.00 (inclusive)
2025-09-13 16:59:23,604 - jwst.extract_1d.extract - INFO - Working on slit 1162
2025-09-13 16:59:23,605 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:59:23,606 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 19.00 (inclusive)
2025-09-13 16:59:23,749 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 16:59:24,815 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_05101_00001_nis_cal.fits>,).
2025-09-13 16:59:24,884 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 16:59:24,900 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 16:59:24,902 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 16:59:24,903 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 16:59:24,904 - jwst.combine_1d.combine1d - WARNING - 2 output pixel numbers were NaN
2025-09-13 16:59:24,905 - jwst.combine_1d.combine1d - WARNING - 22 elements of output had no corresponding input data;
2025-09-13 16:59:24,905 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 16:59:24,952 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 16:59:25,986 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faef738c830>,).
2025-09-13 16:59:25,987 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 16:59:27,005 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faef738c830>,).
2025-09-13 16:59:27,008 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 16:59:27,037 - jwst.extract_1d.extract - INFO - Working on slit 1457
2025-09-13 16:59:27,038 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:59:27,039 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 24.00 (inclusive)
2025-09-13 16:59:27,091 - jwst.extract_1d.extract - INFO - Working on slit 1457
2025-09-13 16:59:27,092 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:59:27,092 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 24.00 (inclusive)
2025-09-13 16:59:27,143 - jwst.extract_1d.extract - INFO - Working on slit 1457
2025-09-13 16:59:27,144 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:59:27,145 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 24.00 (inclusive)
2025-09-13 16:59:27,284 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 16:59:28,300 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_05101_00001_nis_cal.fits>,).
2025-09-13 16:59:28,368 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 16:59:28,385 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 16:59:28,386 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 16:59:28,387 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 16:59:28,389 - jwst.combine_1d.combine1d - WARNING - 3 output pixel numbers were NaN
2025-09-13 16:59:28,389 - jwst.combine_1d.combine1d - WARNING - 25 elements of output had no corresponding input data;
2025-09-13 16:59:28,389 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 16:59:28,436 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 16:59:29,468 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faef738e9f0>,).
2025-09-13 16:59:29,468 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 16:59:30,506 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faef738e9f0>,).
2025-09-13 16:59:30,510 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 16:59:30,539 - jwst.extract_1d.extract - INFO - Working on slit 694
2025-09-13 16:59:30,540 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:59:30,541 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 21.00 (inclusive)
2025-09-13 16:59:30,594 - jwst.extract_1d.extract - INFO - Working on slit 694
2025-09-13 16:59:30,595 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:59:30,596 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 22.00 (inclusive)
2025-09-13 16:59:30,648 - jwst.extract_1d.extract - INFO - Working on slit 694
2025-09-13 16:59:30,649 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:59:30,650 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 22.00 (inclusive)
2025-09-13 16:59:30,791 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 16:59:31,845 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_05101_00001_nis_cal.fits>,).
2025-09-13 16:59:31,914 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 16:59:31,932 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 16:59:31,933 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 16:59:31,935 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 16:59:31,936 - jwst.combine_1d.combine1d - WARNING - 3 output pixel numbers were NaN
2025-09-13 16:59:31,937 - jwst.combine_1d.combine1d - WARNING - 45 elements of output had no corresponding input data;
2025-09-13 16:59:31,937 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 16:59:31,985 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 16:59:33,015 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faebd53f4a0>,).
2025-09-13 16:59:33,015 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 16:59:34,036 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faebd53f4a0>,).
2025-09-13 16:59:34,039 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 16:59:34,068 - jwst.extract_1d.extract - INFO - Working on slit 1266
2025-09-13 16:59:34,069 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:59:34,070 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 26.00 (inclusive)
2025-09-13 16:59:34,122 - jwst.extract_1d.extract - INFO - Working on slit 1266
2025-09-13 16:59:34,123 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:59:34,124 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 26.00 (inclusive)
2025-09-13 16:59:34,175 - jwst.extract_1d.extract - INFO - Working on slit 1266
2025-09-13 16:59:34,176 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:59:34,176 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 27.00 (inclusive)
2025-09-13 16:59:34,316 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 16:59:35,348 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_05101_00001_nis_cal.fits>,).
2025-09-13 16:59:35,416 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 16:59:35,432 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 16:59:35,434 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 16:59:35,435 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 16:59:35,436 - jwst.combine_1d.combine1d - WARNING - 2 output pixel numbers were NaN
2025-09-13 16:59:35,437 - jwst.combine_1d.combine1d - WARNING - 38 elements of output had no corresponding input data;
2025-09-13 16:59:35,437 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 16:59:35,483 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 16:59:36,502 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faebd53c560>,).
2025-09-13 16:59:36,503 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 16:59:37,536 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faebd53c560>,).
2025-09-13 16:59:37,539 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 16:59:37,569 - jwst.extract_1d.extract - INFO - Working on slit 298
2025-09-13 16:59:37,570 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:59:37,571 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 23.00 (inclusive)
2025-09-13 16:59:37,624 - jwst.extract_1d.extract - INFO - Working on slit 298
2025-09-13 16:59:37,625 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:59:37,626 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 22.00 (inclusive)
2025-09-13 16:59:37,678 - jwst.extract_1d.extract - INFO - Working on slit 298
2025-09-13 16:59:37,679 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:59:37,680 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 23.00 (inclusive)
2025-09-13 16:59:37,822 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 16:59:38,901 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_05101_00001_nis_cal.fits>,).
2025-09-13 16:59:38,971 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 16:59:38,989 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 16:59:38,990 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 16:59:38,991 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 16:59:38,992 - jwst.combine_1d.combine1d - WARNING - 3 output pixel numbers were NaN
2025-09-13 16:59:38,993 - jwst.combine_1d.combine1d - WARNING - 34 elements of output had no corresponding input data;
2025-09-13 16:59:38,993 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 16:59:39,040 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 16:59:40,092 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faebd53f0b0>,).
2025-09-13 16:59:40,093 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 16:59:41,100 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faebd53f0b0>,).
2025-09-13 16:59:41,103 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 16:59:41,133 - jwst.extract_1d.extract - INFO - Working on slit 516
2025-09-13 16:59:41,134 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:59:41,134 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 33.00 (inclusive)
2025-09-13 16:59:41,186 - jwst.extract_1d.extract - INFO - Working on slit 516
2025-09-13 16:59:41,187 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:59:41,187 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 33.00 (inclusive)
2025-09-13 16:59:41,238 - jwst.extract_1d.extract - INFO - Working on slit 516
2025-09-13 16:59:41,239 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:59:41,240 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 34.00 (inclusive)
2025-09-13 16:59:41,378 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 16:59:42,387 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_05101_00001_nis_cal.fits>,).
2025-09-13 16:59:42,453 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 16:59:42,470 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 16:59:42,471 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 16:59:42,472 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 16:59:42,474 - jwst.combine_1d.combine1d - WARNING - 3 output pixel numbers were NaN
2025-09-13 16:59:42,474 - jwst.combine_1d.combine1d - WARNING - 32 elements of output had no corresponding input data;
2025-09-13 16:59:42,474 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 16:59:42,521 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 16:59:43,529 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faebd53d520>,).
2025-09-13 16:59:43,530 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 16:59:44,562 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faebd53d520>,).
2025-09-13 16:59:44,566 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 16:59:44,595 - jwst.extract_1d.extract - INFO - Working on slit 973
2025-09-13 16:59:44,596 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:59:44,597 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 20.00 (inclusive)
2025-09-13 16:59:44,650 - jwst.extract_1d.extract - INFO - Working on slit 973
2025-09-13 16:59:44,651 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:59:44,652 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 20.00 (inclusive)
2025-09-13 16:59:44,704 - jwst.extract_1d.extract - INFO - Working on slit 973
2025-09-13 16:59:44,705 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:59:44,706 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 20.00 (inclusive)
2025-09-13 16:59:44,850 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 16:59:45,915 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_05101_00001_nis_cal.fits>,).
2025-09-13 16:59:45,983 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 16:59:46,000 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 16:59:46,001 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 16:59:46,002 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 16:59:46,003 - jwst.combine_1d.combine1d - WARNING - 2 output pixel numbers were NaN
2025-09-13 16:59:46,004 - jwst.combine_1d.combine1d - WARNING - 24 elements of output had no corresponding input data;
2025-09-13 16:59:46,005 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 16:59:46,051 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 16:59:47,093 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faebd53d130>,).
2025-09-13 16:59:47,094 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 16:59:48,121 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faebd53d130>,).
2025-09-13 16:59:48,124 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 16:59:48,154 - jwst.extract_1d.extract - INFO - Working on slit 180
2025-09-13 16:59:48,155 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:59:48,156 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 32.00 (inclusive)
2025-09-13 16:59:48,209 - jwst.extract_1d.extract - INFO - Working on slit 180
2025-09-13 16:59:48,210 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:59:48,210 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 32.00 (inclusive)
2025-09-13 16:59:48,262 - jwst.extract_1d.extract - INFO - Working on slit 180
2025-09-13 16:59:48,263 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:59:48,264 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 32.00 (inclusive)
2025-09-13 16:59:48,404 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 16:59:49,455 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_05101_00001_nis_cal.fits>,).
2025-09-13 16:59:49,523 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 16:59:49,541 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 16:59:49,542 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 16:59:49,543 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 16:59:49,544 - jwst.combine_1d.combine1d - WARNING - 2 output pixel numbers were NaN
2025-09-13 16:59:49,545 - jwst.combine_1d.combine1d - WARNING - 43 elements of output had no corresponding input data;
2025-09-13 16:59:49,545 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 16:59:49,592 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 16:59:50,639 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faebd53d490>,).
2025-09-13 16:59:50,639 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 16:59:51,681 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faebd53d490>,).
2025-09-13 16:59:51,684 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 16:59:51,714 - jwst.extract_1d.extract - INFO - Working on slit 980
2025-09-13 16:59:51,715 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:59:51,716 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 29.00 (inclusive)
2025-09-13 16:59:51,769 - jwst.extract_1d.extract - INFO - Working on slit 980
2025-09-13 16:59:51,770 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:59:51,771 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 30.00 (inclusive)
2025-09-13 16:59:51,823 - jwst.extract_1d.extract - INFO - Working on slit 980
2025-09-13 16:59:51,825 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:59:51,825 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 30.00 (inclusive)
2025-09-13 16:59:51,970 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 16:59:53,074 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_05101_00001_nis_cal.fits>,).
2025-09-13 16:59:53,143 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 16:59:53,161 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 16:59:53,162 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 16:59:53,164 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 16:59:53,165 - jwst.combine_1d.combine1d - WARNING - 2 output pixel numbers were NaN
2025-09-13 16:59:53,165 - jwst.combine_1d.combine1d - WARNING - 39 elements of output had no corresponding input data;
2025-09-13 16:59:53,166 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 16:59:53,213 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 16:59:54,288 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faef3a74320>,).
2025-09-13 16:59:54,289 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 16:59:55,332 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faef3a74320>,).
2025-09-13 16:59:55,335 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 16:59:55,365 - jwst.extract_1d.extract - INFO - Working on slit 263
2025-09-13 16:59:55,366 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:59:55,367 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 24.00 (inclusive)
2025-09-13 16:59:55,419 - jwst.extract_1d.extract - INFO - Working on slit 263
2025-09-13 16:59:55,420 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:59:55,421 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 24.00 (inclusive)
2025-09-13 16:59:55,474 - jwst.extract_1d.extract - INFO - Working on slit 263
2025-09-13 16:59:55,475 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:59:55,476 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 25.00 (inclusive)
2025-09-13 16:59:55,617 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 16:59:56,672 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_05101_00001_nis_cal.fits>,).
2025-09-13 16:59:56,740 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 16:59:56,757 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 16:59:56,759 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 16:59:56,760 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 16:59:56,761 - jwst.combine_1d.combine1d - WARNING - 3 output pixel numbers were NaN
2025-09-13 16:59:56,762 - jwst.combine_1d.combine1d - WARNING - 39 elements of output had no corresponding input data;
2025-09-13 16:59:56,762 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 16:59:56,809 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 16:59:57,880 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faebd53cd40>,).
2025-09-13 16:59:57,880 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 16:59:58,959 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faebd53cd40>,).
2025-09-13 16:59:58,963 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 16:59:58,993 - jwst.extract_1d.extract - INFO - Working on slit 493
2025-09-13 16:59:58,994 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:59:58,995 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 30.00 (inclusive)
2025-09-13 16:59:59,048 - jwst.extract_1d.extract - INFO - Working on slit 493
2025-09-13 16:59:59,049 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:59:59,050 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 30.00 (inclusive)
2025-09-13 16:59:59,103 - jwst.extract_1d.extract - INFO - Working on slit 493
2025-09-13 16:59:59,104 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 16:59:59,105 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 29.00 (inclusive)
2025-09-13 16:59:59,250 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 17:00:00,355 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_05101_00001_nis_cal.fits>,).
2025-09-13 17:00:00,425 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 17:00:00,442 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 17:00:00,443 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 17:00:00,445 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 17:00:00,446 - jwst.combine_1d.combine1d - WARNING - 3 output pixel numbers were NaN
2025-09-13 17:00:00,446 - jwst.combine_1d.combine1d - WARNING - 31 elements of output had no corresponding input data;
2025-09-13 17:00:00,447 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 17:00:00,494 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 17:00:01,604 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faebd53c710>,).
2025-09-13 17:00:01,605 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 17:00:02,744 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faebd53c710>,).
2025-09-13 17:00:02,747 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 17:00:02,777 - jwst.extract_1d.extract - INFO - Working on slit 981
2025-09-13 17:00:02,778 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 17:00:02,778 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 23.00 (inclusive)
2025-09-13 17:00:02,831 - jwst.extract_1d.extract - INFO - Working on slit 981
2025-09-13 17:00:02,832 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 17:00:02,833 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 23.00 (inclusive)
2025-09-13 17:00:02,885 - jwst.extract_1d.extract - INFO - Working on slit 981
2025-09-13 17:00:02,886 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 17:00:02,887 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 22.00 (inclusive)
2025-09-13 17:00:03,030 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 17:00:04,111 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_05101_00001_nis_cal.fits>,).
2025-09-13 17:00:04,180 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 17:00:04,196 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 17:00:04,198 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 17:00:04,199 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 17:00:04,200 - jwst.combine_1d.combine1d - WARNING - 3 output pixel numbers were NaN
2025-09-13 17:00:04,200 - jwst.combine_1d.combine1d - WARNING - 19 elements of output had no corresponding input data;
2025-09-13 17:00:04,201 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 17:00:04,248 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 17:00:05,326 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faebd53ecc0>,).
2025-09-13 17:00:05,327 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 17:00:06,424 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faebd53ecc0>,).
2025-09-13 17:00:06,427 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 17:00:06,458 - jwst.extract_1d.extract - INFO - Working on slit 1371
2025-09-13 17:00:06,459 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 17:00:06,460 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 22.00 (inclusive)
2025-09-13 17:00:06,514 - jwst.extract_1d.extract - INFO - Working on slit 1371
2025-09-13 17:00:06,516 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 17:00:06,516 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 22.00 (inclusive)
2025-09-13 17:00:06,570 - jwst.extract_1d.extract - INFO - Working on slit 1371
2025-09-13 17:00:06,571 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 17:00:06,572 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 23.00 (inclusive)
2025-09-13 17:00:06,718 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 17:00:07,867 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_05101_00001_nis_cal.fits>,).
2025-09-13 17:00:07,935 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 17:00:07,952 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 17:00:07,954 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 17:00:07,955 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 17:00:07,956 - jwst.combine_1d.combine1d - WARNING - 3 output pixel numbers were NaN
2025-09-13 17:00:07,957 - jwst.combine_1d.combine1d - WARNING - 25 elements of output had no corresponding input data;
2025-09-13 17:00:07,957 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 17:00:08,005 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 17:00:09,113 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faebd53f800>,).
2025-09-13 17:00:09,113 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 17:00:10,224 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faebd53f800>,).
2025-09-13 17:00:10,227 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 17:00:10,257 - jwst.extract_1d.extract - INFO - Working on slit 536
2025-09-13 17:00:10,258 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 17:00:10,259 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 34.00 (inclusive)
2025-09-13 17:00:10,313 - jwst.extract_1d.extract - INFO - Working on slit 536
2025-09-13 17:00:10,314 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 17:00:10,315 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 33.00 (inclusive)
2025-09-13 17:00:10,368 - jwst.extract_1d.extract - INFO - Working on slit 536
2025-09-13 17:00:10,370 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 17:00:10,370 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 33.00 (inclusive)
2025-09-13 17:00:10,514 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 17:00:11,618 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_05101_00001_nis_cal.fits>,).
2025-09-13 17:00:11,687 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 17:00:11,703 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 17:00:11,705 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 17:00:11,706 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 17:00:11,707 - jwst.combine_1d.combine1d - WARNING - 2 output pixel numbers were NaN
2025-09-13 17:00:11,708 - jwst.combine_1d.combine1d - WARNING - 24 elements of output had no corresponding input data;
2025-09-13 17:00:11,708 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 17:00:11,755 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 17:00:12,899 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faebd53dc70>,).
2025-09-13 17:00:12,900 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 17:00:14,007 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faebd53dc70>,).
2025-09-13 17:00:14,010 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 17:00:14,040 - jwst.extract_1d.extract - INFO - Working on slit 749
2025-09-13 17:00:14,041 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 17:00:14,042 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 22.00 (inclusive)
2025-09-13 17:00:14,097 - jwst.extract_1d.extract - INFO - Working on slit 749
2025-09-13 17:00:14,098 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 17:00:14,099 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 22.00 (inclusive)
2025-09-13 17:00:14,151 - jwst.extract_1d.extract - INFO - Working on slit 749
2025-09-13 17:00:14,152 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 17:00:14,153 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 22.00 (inclusive)
2025-09-13 17:00:14,296 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 17:00:15,416 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_05101_00001_nis_cal.fits>,).
2025-09-13 17:00:15,484 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 17:00:15,501 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 17:00:15,503 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 17:00:15,504 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 17:00:15,505 - jwst.combine_1d.combine1d - WARNING - 3 output pixel numbers were NaN
2025-09-13 17:00:15,505 - jwst.combine_1d.combine1d - WARNING - 26 elements of output had no corresponding input data;
2025-09-13 17:00:15,505 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 17:00:15,552 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 17:00:16,630 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faebd53eba0>,).
2025-09-13 17:00:16,631 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 17:00:17,718 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faebd53eba0>,).
2025-09-13 17:00:17,722 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 17:00:17,752 - jwst.extract_1d.extract - INFO - Working on slit 345
2025-09-13 17:00:17,753 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 17:00:17,754 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 21.00 (inclusive)
2025-09-13 17:00:17,807 - jwst.extract_1d.extract - INFO - Working on slit 345
2025-09-13 17:00:17,808 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 17:00:17,809 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 21.00 (inclusive)
2025-09-13 17:00:17,861 - jwst.extract_1d.extract - INFO - Working on slit 345
2025-09-13 17:00:17,862 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 17:00:17,863 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 22.00 (inclusive)
2025-09-13 17:00:18,003 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 17:00:19,090 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_05101_00001_nis_cal.fits>,).
2025-09-13 17:00:19,157 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 17:00:19,174 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 17:00:19,175 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 17:00:19,176 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 17:00:19,177 - jwst.combine_1d.combine1d - WARNING - 3 output pixel numbers were NaN
2025-09-13 17:00:19,178 - jwst.combine_1d.combine1d - WARNING - 23 elements of output had no corresponding input data;
2025-09-13 17:00:19,178 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 17:00:19,224 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 17:00:20,310 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faebd53cf80>,).
2025-09-13 17:00:20,311 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 17:00:21,435 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faebd53cf80>,).
2025-09-13 17:00:21,438 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 17:00:21,468 - jwst.extract_1d.extract - INFO - Working on slit 721
2025-09-13 17:00:21,469 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type POINT
2025-09-13 17:00:21,470 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 10.00 (inclusive)
2025-09-13 17:00:21,477 - jwst.extract_1d.extract - INFO - Creating aperture correction.
2025-09-13 17:00:21,593 - jwst.extract_1d.extract - INFO - Working on slit 721
2025-09-13 17:00:21,594 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type POINT
2025-09-13 17:00:21,595 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 10.00 (inclusive)
2025-09-13 17:00:21,602 - jwst.extract_1d.extract - INFO - Creating aperture correction.
2025-09-13 17:00:21,719 - jwst.extract_1d.extract - INFO - Working on slit 721
2025-09-13 17:00:21,720 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type POINT
2025-09-13 17:00:21,720 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 10.00 (inclusive)
2025-09-13 17:00:21,727 - jwst.extract_1d.extract - INFO - Creating aperture correction.
2025-09-13 17:00:21,938 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 17:00:23,063 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_05101_00001_nis_cal.fits>,).
2025-09-13 17:00:23,133 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 17:00:23,149 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 17:00:23,151 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 17:00:23,152 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 17:00:23,153 - jwst.combine_1d.combine1d - WARNING - 3 output pixel numbers were NaN
2025-09-13 17:00:23,153 - jwst.combine_1d.combine1d - WARNING - 18 elements of output had no corresponding input data;
2025-09-13 17:00:23,154 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 17:00:23,200 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 17:00:24,281 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faee866b0b0>,).
2025-09-13 17:00:24,282 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 17:00:25,378 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faee866b0b0>,).
2025-09-13 17:00:25,382 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 17:00:25,415 - jwst.extract_1d.extract - INFO - Working on slit 387
2025-09-13 17:00:25,416 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 17:00:25,417 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 18.00 (inclusive)
2025-09-13 17:00:25,470 - jwst.extract_1d.extract - INFO - Working on slit 387
2025-09-13 17:00:25,471 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 17:00:25,472 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 19.00 (inclusive)
2025-09-13 17:00:25,524 - jwst.extract_1d.extract - INFO - Working on slit 387
2025-09-13 17:00:25,525 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 17:00:25,526 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 19.00 (inclusive)
2025-09-13 17:00:25,667 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 17:00:26,750 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_05101_00001_nis_cal.fits>,).
2025-09-13 17:00:26,820 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 17:00:26,837 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 17:00:26,838 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 17:00:26,839 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 17:00:26,840 - jwst.combine_1d.combine1d - WARNING - 3 output pixel numbers were NaN
2025-09-13 17:00:26,840 - jwst.combine_1d.combine1d - WARNING - 25 elements of output had no corresponding input data;
2025-09-13 17:00:26,841 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 17:00:26,887 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 17:00:27,974 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faee866b800>,).
2025-09-13 17:00:27,975 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 17:00:29,081 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faee866b800>,).
2025-09-13 17:00:29,084 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 17:00:29,113 - jwst.extract_1d.extract - INFO - Working on slit 505
2025-09-13 17:00:29,114 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 17:00:29,115 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 21.00 (inclusive)
2025-09-13 17:00:29,168 - jwst.extract_1d.extract - INFO - Working on slit 505
2025-09-13 17:00:29,169 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 17:00:29,170 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 21.00 (inclusive)
2025-09-13 17:00:29,222 - jwst.extract_1d.extract - INFO - Working on slit 505
2025-09-13 17:00:29,223 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 17:00:29,224 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 21.00 (inclusive)
2025-09-13 17:00:29,366 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 17:00:30,468 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_05101_00001_nis_cal.fits>,).
2025-09-13 17:00:30,536 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 17:00:30,552 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 17:00:30,553 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 17:00:30,554 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 17:00:30,555 - jwst.combine_1d.combine1d - WARNING - 3 output pixel numbers were NaN
2025-09-13 17:00:30,556 - jwst.combine_1d.combine1d - WARNING - 22 elements of output had no corresponding input data;
2025-09-13 17:00:30,556 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 17:00:30,602 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 17:00:31,679 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faee866a9f0>,).
2025-09-13 17:00:31,679 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 17:00:32,754 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faee866a9f0>,).
2025-09-13 17:00:32,757 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 17:00:32,788 - jwst.extract_1d.extract - INFO - Working on slit 566
2025-09-13 17:00:32,789 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 17:00:32,789 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 35.00 (inclusive)
2025-09-13 17:00:32,843 - jwst.extract_1d.extract - INFO - Working on slit 566
2025-09-13 17:00:32,844 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 17:00:32,845 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 36.00 (inclusive)
2025-09-13 17:00:32,898 - jwst.extract_1d.extract - INFO - Working on slit 566
2025-09-13 17:00:32,899 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 17:00:32,900 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 36.00 (inclusive)
2025-09-13 17:00:33,045 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 17:00:34,125 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_05101_00001_nis_cal.fits>,).
2025-09-13 17:00:34,192 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 17:00:34,208 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 17:00:34,209 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 17:00:34,210 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 17:00:34,211 - jwst.combine_1d.combine1d - WARNING - 2 output pixel numbers were NaN
2025-09-13 17:00:34,212 - jwst.combine_1d.combine1d - WARNING - 25 elements of output had no corresponding input data;
2025-09-13 17:00:34,212 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 17:00:34,258 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 17:00:35,322 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faee8669910>,).
2025-09-13 17:00:35,322 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 17:00:36,428 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faee8669910>,).
2025-09-13 17:00:36,432 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 17:00:36,461 - jwst.extract_1d.extract - INFO - Working on slit 772
2025-09-13 17:00:36,462 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 17:00:36,463 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 25.00 (inclusive)
2025-09-13 17:00:36,517 - jwst.extract_1d.extract - INFO - Working on slit 772
2025-09-13 17:00:36,518 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 17:00:36,519 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 25.00 (inclusive)
2025-09-13 17:00:36,571 - jwst.extract_1d.extract - INFO - Working on slit 772
2025-09-13 17:00:36,572 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 17:00:36,573 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 25.00 (inclusive)
2025-09-13 17:00:36,718 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 17:00:37,798 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_05101_00001_nis_cal.fits>,).
2025-09-13 17:00:37,865 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 17:00:37,881 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 17:00:37,883 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 17:00:37,884 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 17:00:37,885 - jwst.combine_1d.combine1d - WARNING - 3 output pixel numbers were NaN
2025-09-13 17:00:37,886 - jwst.combine_1d.combine1d - WARNING - 25 elements of output had no corresponding input data;
2025-09-13 17:00:37,886 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 17:00:37,933 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 17:00:39,001 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faee8668560>,).
2025-09-13 17:00:39,002 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 17:00:40,079 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faee8668560>,).
2025-09-13 17:00:40,082 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 17:00:40,112 - jwst.extract_1d.extract - INFO - Working on slit 722
2025-09-13 17:00:40,113 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 17:00:40,114 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 26.00 (inclusive)
2025-09-13 17:00:40,165 - jwst.extract_1d.extract - INFO - Working on slit 722
2025-09-13 17:00:40,166 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 17:00:40,167 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 27.00 (inclusive)
2025-09-13 17:00:40,218 - jwst.extract_1d.extract - INFO - Working on slit 722
2025-09-13 17:00:40,219 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 17:00:40,220 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 26.00 (inclusive)
2025-09-13 17:00:40,360 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 17:00:41,409 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_05101_00001_nis_cal.fits>,).
2025-09-13 17:00:41,476 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 17:00:41,492 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 17:00:41,493 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 17:00:41,495 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 17:00:41,496 - jwst.combine_1d.combine1d - WARNING - 3 output pixel numbers were NaN
2025-09-13 17:00:41,496 - jwst.combine_1d.combine1d - WARNING - 32 elements of output had no corresponding input data;
2025-09-13 17:00:41,497 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 17:00:41,543 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 17:00:42,619 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faee8668710>,).
2025-09-13 17:00:42,619 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 17:00:43,697 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faee8668710>,).
2025-09-13 17:00:43,700 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 17:00:43,730 - jwst.extract_1d.extract - INFO - Working on slit 872
2025-09-13 17:00:43,731 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type POINT
2025-09-13 17:00:43,731 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 10.00 (inclusive)
2025-09-13 17:00:43,738 - jwst.extract_1d.extract - INFO - Creating aperture correction.
2025-09-13 17:00:43,857 - jwst.extract_1d.extract - INFO - Working on slit 872
2025-09-13 17:00:43,858 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type POINT
2025-09-13 17:00:43,859 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 10.00 (inclusive)
2025-09-13 17:00:43,866 - jwst.extract_1d.extract - INFO - Creating aperture correction.
2025-09-13 17:00:43,988 - jwst.extract_1d.extract - INFO - Working on slit 872
2025-09-13 17:00:43,989 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type POINT
2025-09-13 17:00:43,991 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 10.00 (inclusive)
2025-09-13 17:00:43,997 - jwst.extract_1d.extract - INFO - Creating aperture correction.
2025-09-13 17:00:44,211 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 17:00:45,296 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_05101_00001_nis_cal.fits>,).
2025-09-13 17:00:45,363 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 17:00:45,380 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 17:00:45,381 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 17:00:45,382 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 17:00:45,383 - jwst.combine_1d.combine1d - WARNING - 2 output pixel numbers were NaN
2025-09-13 17:00:45,384 - jwst.combine_1d.combine1d - WARNING - 25 elements of output had no corresponding input data;
2025-09-13 17:00:45,384 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 17:00:45,431 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 17:00:46,489 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faebb2b7a40>,).
2025-09-13 17:00:46,490 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 17:00:47,557 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faebb2b7a40>,).
2025-09-13 17:00:47,560 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 17:00:47,590 - jwst.extract_1d.extract - INFO - Working on slit 933
2025-09-13 17:00:47,591 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 17:00:47,591 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 24.00 (inclusive)
2025-09-13 17:00:47,643 - jwst.extract_1d.extract - INFO - Working on slit 933
2025-09-13 17:00:47,644 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 17:00:47,645 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 24.00 (inclusive)
2025-09-13 17:00:47,698 - jwst.extract_1d.extract - INFO - Working on slit 933
2025-09-13 17:00:47,699 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 17:00:47,699 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 25.00 (inclusive)
2025-09-13 17:00:47,840 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 17:00:48,896 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_05101_00001_nis_cal.fits>,).
2025-09-13 17:00:48,963 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 17:00:48,980 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 17:00:48,981 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 17:00:48,983 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 17:00:48,984 - jwst.combine_1d.combine1d - WARNING - 3 output pixel numbers were NaN
2025-09-13 17:00:48,984 - jwst.combine_1d.combine1d - WARNING - 37 elements of output had no corresponding input data;
2025-09-13 17:00:48,985 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 17:00:49,032 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 17:00:50,132 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faebb2b5250>,).
2025-09-13 17:00:50,132 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 17:00:51,226 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faebb2b5250>,).
2025-09-13 17:00:51,229 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 17:00:51,259 - jwst.extract_1d.extract - INFO - Working on slit 1128
2025-09-13 17:00:51,260 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type POINT
2025-09-13 17:00:51,261 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 10.00 (inclusive)
2025-09-13 17:00:51,268 - jwst.extract_1d.extract - INFO - Creating aperture correction.
2025-09-13 17:00:51,383 - jwst.extract_1d.extract - INFO - Working on slit 1128
2025-09-13 17:00:51,385 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type POINT
2025-09-13 17:00:51,385 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 10.00 (inclusive)
2025-09-13 17:00:51,392 - jwst.extract_1d.extract - INFO - Creating aperture correction.
2025-09-13 17:00:51,508 - jwst.extract_1d.extract - INFO - Working on slit 1128
2025-09-13 17:00:51,509 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type POINT
2025-09-13 17:00:51,510 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 10.00 (inclusive)
2025-09-13 17:00:51,516 - jwst.extract_1d.extract - INFO - Creating aperture correction.
2025-09-13 17:00:51,718 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 17:00:52,790 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_05101_00001_nis_cal.fits>,).
2025-09-13 17:00:52,858 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 17:00:52,873 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 17:00:52,875 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 17:00:52,876 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 17:00:52,877 - jwst.combine_1d.combine1d - WARNING - 2 output pixel numbers were NaN
2025-09-13 17:00:52,877 - jwst.combine_1d.combine1d - WARNING - 16 elements of output had no corresponding input data;
2025-09-13 17:00:52,878 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 17:00:52,925 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 17:00:54,004 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faebb2b6330>,).
2025-09-13 17:00:54,005 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 17:00:55,093 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faebb2b6330>,).
2025-09-13 17:00:55,096 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 17:00:55,126 - jwst.extract_1d.extract - INFO - Working on slit 1282
2025-09-13 17:00:55,127 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 17:00:55,128 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 35.00 (inclusive)
2025-09-13 17:00:55,181 - jwst.extract_1d.extract - INFO - Working on slit 1282
2025-09-13 17:00:55,182 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 17:00:55,183 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 34.00 (inclusive)
2025-09-13 17:00:55,235 - jwst.extract_1d.extract - INFO - Working on slit 1282
2025-09-13 17:00:55,236 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 17:00:55,237 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 34.00 (inclusive)
2025-09-13 17:00:55,380 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 17:00:56,473 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_05101_00001_nis_cal.fits>,).
2025-09-13 17:00:56,543 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 17:00:56,560 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 17:00:56,562 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 17:00:56,563 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 17:00:56,564 - jwst.combine_1d.combine1d - WARNING - 3 output pixel numbers were NaN
2025-09-13 17:00:56,564 - jwst.combine_1d.combine1d - WARNING - 35 elements of output had no corresponding input data;
2025-09-13 17:00:56,565 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 17:00:56,612 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 17:00:57,745 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faebb2b6f90>,).
2025-09-13 17:00:57,746 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 17:00:58,858 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faebb2b6f90>,).
2025-09-13 17:00:58,861 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 17:00:58,890 - jwst.extract_1d.extract - INFO - Working on slit 274
2025-09-13 17:00:58,891 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 17:00:58,892 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 31.00 (inclusive)
2025-09-13 17:00:58,944 - jwst.extract_1d.extract - INFO - Working on slit 274
2025-09-13 17:00:58,945 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 17:00:58,946 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 31.00 (inclusive)
2025-09-13 17:00:58,997 - jwst.extract_1d.extract - INFO - Working on slit 274
2025-09-13 17:00:58,998 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 17:00:58,999 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 32.00 (inclusive)
2025-09-13 17:00:59,139 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 17:01:00,211 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_05101_00001_nis_cal.fits>,).
2025-09-13 17:01:00,278 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 17:01:00,295 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 17:01:00,296 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 17:01:00,297 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 17:01:00,299 - jwst.combine_1d.combine1d - WARNING - 2 output pixel numbers were NaN
2025-09-13 17:01:00,299 - jwst.combine_1d.combine1d - WARNING - 32 elements of output had no corresponding input data;
2025-09-13 17:01:00,300 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 17:01:00,346 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 17:01:01,412 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faebb2b5a30>,).
2025-09-13 17:01:01,413 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 17:01:02,505 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faebb2b5a30>,).
2025-09-13 17:01:02,508 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 17:01:02,538 - jwst.extract_1d.extract - INFO - Working on slit 641
2025-09-13 17:01:02,539 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 17:01:02,540 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 23.00 (inclusive)
2025-09-13 17:01:02,592 - jwst.extract_1d.extract - INFO - Working on slit 641
2025-09-13 17:01:02,594 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 17:01:02,594 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 23.00 (inclusive)
2025-09-13 17:01:02,646 - jwst.extract_1d.extract - INFO - Working on slit 641
2025-09-13 17:01:02,647 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 17:01:02,648 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 22.00 (inclusive)
2025-09-13 17:01:02,792 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 17:01:03,868 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_05101_00001_nis_cal.fits>,).
2025-09-13 17:01:03,937 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 17:01:03,954 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 17:01:03,955 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 17:01:03,957 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 17:01:03,958 - jwst.combine_1d.combine1d - WARNING - 3 output pixel numbers were NaN
2025-09-13 17:01:03,959 - jwst.combine_1d.combine1d - WARNING - 29 elements of output had no corresponding input data;
2025-09-13 17:01:03,959 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 17:01:04,007 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 17:01:05,122 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faebb2b7140>,).
2025-09-13 17:01:05,123 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 17:01:06,219 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faebb2b7140>,).
2025-09-13 17:01:06,222 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 17:01:06,251 - jwst.extract_1d.extract - INFO - Working on slit 543
2025-09-13 17:01:06,252 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 17:01:06,253 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 29.00 (inclusive)
2025-09-13 17:01:06,305 - jwst.extract_1d.extract - INFO - Working on slit 543
2025-09-13 17:01:06,306 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 17:01:06,307 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 29.00 (inclusive)
2025-09-13 17:01:06,358 - jwst.extract_1d.extract - INFO - Working on slit 543
2025-09-13 17:01:06,359 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 17:01:06,360 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 28.00 (inclusive)
2025-09-13 17:01:06,501 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 17:01:07,580 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_05101_00001_nis_cal.fits>,).
2025-09-13 17:01:07,646 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 17:01:07,663 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 17:01:07,664 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 17:01:07,665 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 17:01:07,667 - jwst.combine_1d.combine1d - WARNING - 3 output pixel numbers were NaN
2025-09-13 17:01:07,667 - jwst.combine_1d.combine1d - WARNING - 33 elements of output had no corresponding input data;
2025-09-13 17:01:07,668 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 17:01:07,714 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 17:01:08,768 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faebb2b55b0>,).
2025-09-13 17:01:08,768 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 17:01:09,847 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faebb2b55b0>,).
2025-09-13 17:01:09,850 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 17:01:09,879 - jwst.extract_1d.extract - INFO - Working on slit 610
2025-09-13 17:01:09,880 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type POINT
2025-09-13 17:01:09,880 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 10.00 (inclusive)
2025-09-13 17:01:09,887 - jwst.extract_1d.extract - INFO - Creating aperture correction.
2025-09-13 17:01:09,945 - jwst.extract_1d.extract - INFO - Working on slit 610
2025-09-13 17:01:09,946 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type POINT
2025-09-13 17:01:09,947 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 10.00 (inclusive)
2025-09-13 17:01:09,953 - jwst.extract_1d.extract - INFO - Creating aperture correction.
2025-09-13 17:01:10,014 - jwst.extract_1d.extract - INFO - Working on slit 610
2025-09-13 17:01:10,015 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type POINT
2025-09-13 17:01:10,015 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 10.00 (inclusive)
2025-09-13 17:01:10,022 - jwst.extract_1d.extract - INFO - Creating aperture correction.
2025-09-13 17:01:10,165 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 17:01:11,241 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_05101_00001_nis_cal.fits>,).
2025-09-13 17:01:11,309 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 17:01:11,310 - jwst.combine_1d.combine1d - WARNING - Input spectrum 610 order 1 from group_id jw02079004003_05101_1_1 has no valid flux values; skipping.
2025-09-13 17:01:11,311 - jwst.combine_1d.combine1d - WARNING - Input spectrum 610 order 1 from group_id jw02079004003_05101_3_1 has no valid flux values; skipping.
2025-09-13 17:01:11,318 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 17:01:11,319 - jwst.combine_1d.combine1d - WARNING - 16 elements of output had no corresponding input data;
2025-09-13 17:01:11,320 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 17:01:11,366 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 17:01:12,451 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faebb2b51c0>,).
2025-09-13 17:01:12,452 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 17:01:13,524 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faebb2b51c0>,).
2025-09-13 17:01:13,527 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 17:01:13,556 - jwst.extract_1d.extract - INFO - Working on slit 1188
2025-09-13 17:01:13,557 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 17:01:13,558 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 37.00 (inclusive)
2025-09-13 17:01:13,609 - jwst.extract_1d.extract - INFO - Working on slit 1188
2025-09-13 17:01:13,610 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 17:01:13,611 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 38.00 (inclusive)
2025-09-13 17:01:13,661 - jwst.extract_1d.extract - INFO - Working on slit 1188
2025-09-13 17:01:13,662 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 17:01:13,663 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 37.00 (inclusive)
2025-09-13 17:01:13,801 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 17:01:14,848 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_05101_00001_nis_cal.fits>,).
2025-09-13 17:01:14,915 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 17:01:14,930 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 17:01:14,932 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 17:01:14,933 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 17:01:14,934 - jwst.combine_1d.combine1d - WARNING - 3 output pixel numbers were NaN
2025-09-13 17:01:14,935 - jwst.combine_1d.combine1d - WARNING - 19 elements of output had no corresponding input data;
2025-09-13 17:01:14,935 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 17:01:14,981 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 17:01:16,023 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faebb2b5eb0>,).
2025-09-13 17:01:16,024 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 17:01:17,064 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faebb2b5eb0>,).
2025-09-13 17:01:17,068 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 17:01:17,097 - jwst.extract_1d.extract - INFO - Working on slit 533
2025-09-13 17:01:17,098 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 17:01:17,099 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 21.00 (inclusive)
2025-09-13 17:01:17,151 - jwst.extract_1d.extract - INFO - Working on slit 533
2025-09-13 17:01:17,152 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 17:01:17,152 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 21.00 (inclusive)
2025-09-13 17:01:17,204 - jwst.extract_1d.extract - INFO - Working on slit 533
2025-09-13 17:01:17,204 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 17:01:17,205 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 21.00 (inclusive)
2025-09-13 17:01:17,344 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 17:01:18,409 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_05101_00001_nis_cal.fits>,).
2025-09-13 17:01:18,477 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 17:01:18,494 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 17:01:18,495 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 17:01:18,496 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 3
2025-09-13 17:01:18,497 - jwst.combine_1d.combine1d - WARNING - 3 output pixel numbers were NaN
2025-09-13 17:01:18,498 - jwst.combine_1d.combine1d - WARNING - 25 elements of output had no corresponding input data;
2025-09-13 17:01:18,498 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 17:01:18,545 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 17:01:19,648 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faee9b983b0>,).
2025-09-13 17:01:19,649 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 17:01:20,716 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faee9b983b0>,).
2025-09-13 17:01:20,719 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 17:01:20,749 - jwst.extract_1d.extract - INFO - Working on slit 1342
2025-09-13 17:01:20,750 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 17:01:20,751 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 22.00 (inclusive)
2025-09-13 17:01:20,802 - jwst.extract_1d.extract - INFO - Working on slit 1342
2025-09-13 17:01:20,803 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 17:01:20,804 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 22.00 (inclusive)
2025-09-13 17:01:20,927 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 17:01:21,986 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_05101_00001_nis_cal.fits>,).
2025-09-13 17:01:22,037 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 17:01:22,051 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 17:01:22,052 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 2
2025-09-13 17:01:22,054 - jwst.combine_1d.combine1d - WARNING - 1 output pixel numbers were NaN
2025-09-13 17:01:22,054 - jwst.combine_1d.combine1d - WARNING - 22 elements of output had no corresponding input data;
2025-09-13 17:01:22,054 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 17:01:22,101 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 17:01:23,190 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step pixel_replace running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faee9b9b4a0>,).
2025-09-13 17:01:23,190 - stpipe.Spec3Pipeline.pixel_replace - INFO - Step skipped.
2025-09-13 17:01:24,243 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d running with args (<jwst.datamodels.source_container.SourceModelContainer object at 0x7faee9b9b4a0>,).
2025-09-13 17:01:24,247 - stpipe.Spec3Pipeline.extract_1d - INFO - Using APCORR file /home/runner/crds/references/jwst/niriss/jwst_niriss_apcorr_0004.fits
2025-09-13 17:01:24,278 - jwst.extract_1d.extract - INFO - Processing spectral order 1
2025-09-13 17:01:24,279 - jwst.extract_1d.extract - INFO - Setting use_source_posn to False for exposure type NIS_WFSS, source type EXTENDED
2025-09-13 17:01:24,280 - jwst.extract_1d.extract - INFO - Aperture start/stop: 0.00 -> 6.00 (inclusive)
2025-09-13 17:01:24,381 - stpipe.Spec3Pipeline.extract_1d - INFO - Step extract_1d done
2025-09-13 17:01:25,458 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d running with args (<WFSSMultiSpecModel from jw02079004003_05101_00002_nis_cal.fits>,).
2025-09-13 17:01:25,494 - jwst.combine_1d.combine1d - INFO - Using exposure time as the weight.
2025-09-13 17:01:25,502 - jwst.combine_1d.combine1d - INFO - Accumulating data from input spectrum 1
2025-09-13 17:01:25,504 - jwst.combine_1d.combine1d - WARNING - 21 elements of output had no corresponding input data;
2025-09-13 17:01:25,505 - jwst.combine_1d.combine1d - WARNING - these elements will be omitted.
2025-09-13 17:01:25,551 - stpipe.Spec3Pipeline.combine_1d - INFO - Step combine_1d done
2025-09-13 17:01:31,858 - stpipe.Spec3Pipeline - INFO - Saving the final x1d product as jw02079-o004_niriss_gr150c-f200w_x1d.fits.
2025-09-13 17:01:32,025 - stpipe.Spec3Pipeline - INFO - Saving the final c1d product as jw02079-o004_niriss_gr150c-f200w_c1d.fits.
2025-09-13 17:01:32,073 - stpipe.Spec3Pipeline - INFO - Ending calwebb_spec3
2025-09-13 17:01:32,203 - stpipe.Spec3Pipeline - INFO - Step Spec3Pipeline done
2025-09-13 17:01:32,204 - jwst.stpipe.core - INFO - Results used jwst version: 1.19.1
# Print out the time benchmark
time_spec3_end = time.perf_counter()
print(f"Runtime for Spec3: {(time_spec3_end - time_spec3)/60:0.0f} minutes")
Runtime for Spec3: 14 minutes
11. Understanding the Spec3 Outputs#
The outputs of spec3 are *_x1d.fits
and *_c1d.fits
files. Here we do a quick look into some important parts of these files.
Each extension of the spec3 *_x1d.fits
files contains the extracted, 1-D spectra for an individual dither for a single grism, filter, and extracted order combination. The specific filenames and extracted order can be verified with the FILENAME
and SPORDER
keywords in the header of each extension respectively. Within the extension, each of the extracted sources across all dithers are listed, with the values being empty if the particular dither did not contain data for that source. Also contained within each extension is information related to the extraction of a particular source, including the extents and starting size of the extraction box in the full reference frame. More information about the columns contained withing the *_x1d.fits
files can be found in the x1d filetype documentation.
# Print a list of the spec3 output x1d and c1d files
spec3_x1ds = sorted(glob.glob(os.path.join(spec3_dir, "*x1d.fits")))
print('spec3 x1d files:')
for x1d_filename in spec3_x1ds:
print(f" {os.path.basename(x1d_filename)}")
spec3_c1ds = sorted(glob.glob(os.path.join(spec3_dir, "*c1d.fits")))
print('spec3 c1d files:')
for c1d_filename in spec3_c1ds:
print(f" {os.path.basename(c1d_filename)}")
spec3 x1d files:
jw02079-o004_niriss_gr150c-f200w_x1d.fits
jw02079-o004_niriss_gr150r-f200w_x1d.fits
spec3 c1d files:
jw02079-o004_niriss_gr150c-f200w_c1d.fits
jw02079-o004_niriss_gr150r-f200w_c1d.fits
# Print information about the structure of the x1d files by reading in the first one
if doviz:
sample_x1d = fits.open(spec3_x1ds[0])
print("***Format of the level 3 x1d file:")
sample_x1d.info()
print("\n***cal files used to create this level 3 x1d file:")
for ext in range(len(sample_x1d))[1:-1]:
print(f"Extension {ext}: {sample_x1d[ext].header['FILENAME']}, order {sample_x1d[ext].header['SPORDER']}")
print("\n***Columns contained in each extension of the level 3 x1d file:")
print(sample_x1d[1].data.columns)
***Format of the level 3 x1d file:
Filename: /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage3_spec/jw02079-o004_niriss_gr150c-f200w_x1d.fits
No. Name Ver Type Cards Dimensions Format
0 PRIMARY 1 PrimaryHDU 363 ()
1 EXTRACT1D 1 BinTableHDU 123 101R x 29C [J, 271D, 271D, 271D, 271D, 271D, 271D, 271D, 271D, 271D, 271D, 271D, 271J, 271D, 271D, 271D, 271D, 271D, 271D, J, 20A, D, D, D, D, J, J, J, J]
2 EXTRACT1D 2 BinTableHDU 122 101R x 29C [J, 271D, 271D, 271D, 271D, 271D, 271D, 271D, 271D, 271D, 271D, 271D, 271J, 271D, 271D, 271D, 271D, 271D, 271D, J, 20A, D, D, D, D, J, J, J, J]
3 EXTRACT1D 3 BinTableHDU 122 101R x 29C [J, 271D, 271D, 271D, 271D, 271D, 271D, 271D, 271D, 271D, 271D, 271D, 271J, 271D, 271D, 271D, 271D, 271D, 271D, J, 20A, D, D, D, D, J, J, J, J]
4 ASDF 1 BinTableHDU 11 1R x 1C [15432B]
***cal files used to create this level 3 x1d file:
Extension 1: jw02079004003_05101_00001_nis_cal.fits, order 1
Extension 2: jw02079004003_05101_00002_nis_cal.fits, order 1
Extension 3: jw02079004003_05101_00003_nis_cal.fits, order 1
***Columns contained in each extension of the level 3 x1d file:
ColDefs(
name = 'SOURCE_ID'; format = 'J'
name = 'WAVELENGTH'; format = '271D'; unit = 'um'; dim = '(271)'
name = 'FLUX'; format = '271D'; unit = 'Jy'; dim = '(271)'
name = 'FLUX_ERROR'; format = '271D'; unit = 'Jy'; dim = '(271)'
name = 'FLUX_VAR_POISSON'; format = '271D'; unit = 'Jy^2'; dim = '(271)'
name = 'FLUX_VAR_RNOISE'; format = '271D'; unit = 'Jy^2'; dim = '(271)'
name = 'FLUX_VAR_FLAT'; format = '271D'; unit = 'Jy^2'; dim = '(271)'
name = 'SURF_BRIGHT'; format = '271D'; unit = 'MJy/sr'; dim = '(271)'
name = 'SB_ERROR'; format = '271D'; unit = 'MJy/sr'; dim = '(271)'
name = 'SB_VAR_POISSON'; format = '271D'; unit = 'MJy^2 / sr^2'; dim = '(271)'
name = 'SB_VAR_RNOISE'; format = '271D'; unit = 'MJy^2 / sr^2'; dim = '(271)'
name = 'SB_VAR_FLAT'; format = '271D'; unit = 'MJy^2 / sr^2'; dim = '(271)'
name = 'DQ'; format = '271J'; bzero = 2147483648; dim = '(271)'
name = 'BACKGROUND'; format = '271D'; unit = 'MJy/sr'; dim = '(271)'
name = 'BKGD_ERROR'; format = '271D'; unit = 'MJy/sr'; dim = '(271)'
name = 'BKGD_VAR_POISSON'; format = '271D'; unit = 'MJy^2 / sr^2'; dim = '(271)'
name = 'BKGD_VAR_RNOISE'; format = '271D'; unit = 'MJy^2 / sr^2'; dim = '(271)'
name = 'BKGD_VAR_FLAT'; format = '271D'; unit = 'MJy^2 / sr^2'; dim = '(271)'
name = 'NPIXELS'; format = '271D'; dim = '(271)'
name = 'N_ALONGDISP'; format = 'J'; bzero = 2147483648
name = 'SOURCE_TYPE'; format = '20A'
name = 'SOURCE_XPOS'; format = 'D'; unit = 'pix'
name = 'SOURCE_YPOS'; format = 'D'; unit = 'pix'
name = 'SOURCE_RA'; format = 'D'; unit = 'deg'
name = 'SOURCE_DEC'; format = 'D'; unit = 'deg'
name = 'EXTRACT2D_XSTART'; format = 'J'; unit = 'pix'; bzero = 2147483648
name = 'EXTRACT2D_YSTART'; format = 'J'; unit = 'pix'; bzero = 2147483648
name = 'EXTRACT2D_XSTOP'; format = 'J'; unit = 'pix'; bzero = 2147483648
name = 'EXTRACT2D_YSTOP'; format = 'J'; unit = 'pix'; bzero = 2147483648
)
The *_c1d.fits
files contain combined extensions of the same order in the spec3 *_x1d.fits
files into a single file. The source numbers in the *_c1d.fits
match those in the level 3 *_x1d.fits
files. More information about the columns contained within the *_c1d.fits
files can be found in the c1d filetype documentation.
# Print information about the structure of the c1d files by reading in the first one
if doviz:
sample_c1d = fits.open(spec3_c1ds[0])
print("***Format of the c1d file:")
sample_c1d.info()
print("\n***Extracted orders contained in the c1d file:")
for ext in range(len(sample_c1d))[1:-1]:
print(f"Extension {ext}: order {sample_c1d[ext].header['SPORDER']}")
print("\n***Columns contained in each extension of the c1d file:")
print(sample_c1d[1].data.columns)
***Format of the c1d file:
Filename: /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRISS/WFSS/nis_wfss_demo_data/PID02079/obs004/stage3_spec/jw02079-o004_niriss_gr150c-f200w_c1d.fits
No. Name Ver Type Cards Dimensions Format
0 PRIMARY 1 PrimaryHDU 368 ()
1 COMBINE1D 1 BinTableHDU 55 100R x 13C [J, 124D, 124D, 124D, 124D, 124D, 124J, 124D, 124D, J, 20A, D, D]
2 ASDF 1 BinTableHDU 11 1R x 1C [8494B]
***Extracted orders contained in the c1d file:
Extension 1: order 1
***Columns contained in each extension of the c1d file:
ColDefs(
name = 'SOURCE_ID'; format = 'J'
name = 'WAVELENGTH'; format = '124D'; unit = 'um'; dim = '(124)'
name = 'FLUX'; format = '124D'; unit = 'Jy'; dim = '(124)'
name = 'ERROR'; format = '124D'; unit = 'Jy'; dim = '(124)'
name = 'SURF_BRIGHT'; format = '124D'; unit = 'MJy/sr'; dim = '(124)'
name = 'SB_ERROR'; format = '124D'; unit = 'MJy/sr'; dim = '(124)'
name = 'DQ'; format = '124J'; bzero = 2147483648; dim = '(124)'
name = 'WEIGHT'; format = '124D'; dim = '(124)'
name = 'N_INPUT'; format = '124D'; dim = '(124)'
name = 'N_ALONGDISP'; format = 'J'; bzero = 2147483648
name = 'SOURCE_TYPE'; format = '20A'
name = 'SOURCE_RA'; format = 'D'; unit = 'deg'
name = 'SOURCE_DEC'; format = 'D'; unit = 'deg'
)
Digging a little bit further into the different source IDs and how those are handled, you can see that in each extension the source IDs are now identical, which is not always the case in the level 2 x1d files.
if doviz:
for ext in np.arange(len(sample_x1d))[1:-1]:
print(f"Extension {ext}: {sample_x1d[ext].header['FILENAME']}, Order {sample_x1d[ext].header['SPORDER']}")
print(" Sources:\n", sample_x1d[ext].data['SOURCE_ID'])
Extension 1: jw02079004003_05101_00001_nis_cal.fits, Order 1
Sources:
[ 124 180 189 214 220 263 274 276 289 298 345 347 385 387
389 417 422 439 493 505 516 522 527 533 536 539 540 543
553 557 566 567 605 606 610 630 641 649 654 682 693 694
712 719 721 722 732 733 736 749 759 766 772 796 800 821
872 873 881 898 914 922 925 927 933 934 966 973 980 981
982 1008 1029 1049 1084 1120 1128 1140 1142 1162 1188 1194 1219 1253
1257 1266 1282 1296 1342 1364 1371 1387 1388 1407 1412 1417 1423 1442
1457 1476 1479]
Extension 2: jw02079004003_05101_00002_nis_cal.fits, Order 1
Sources:
[ 124 180 189 214 220 263 274 276 289 298 345 347 385 387
389 417 422 439 493 505 516 522 527 533 536 539 540 543
553 557 566 567 605 606 610 630 641 649 654 682 693 694
712 719 721 722 732 733 736 749 759 766 772 796 800 821
872 873 881 898 914 922 925 927 933 934 966 973 980 981
982 1008 1029 1049 1084 1120 1128 1140 1142 1162 1188 1194 1219 1253
1257 1266 1282 1296 1342 1364 1371 1387 1388 1407 1412 1417 1423 1442
1457 1476 1479]
Extension 3: jw02079004003_05101_00003_nis_cal.fits, Order 1
Sources:
[ 124 180 189 214 220 263 274 276 289 298 345 347 385 387
389 417 422 439 493 505 516 522 527 533 536 539 540 543
553 557 566 567 605 606 610 630 641 649 654 682 693 694
712 719 721 722 732 733 736 749 759 766 772 796 800 821
872 873 881 898 914 922 925 927 933 934 966 973 980 981
982 1008 1029 1049 1084 1120 1128 1140 1142 1162 1188 1194 1219 1253
1257 1266 1282 1296 1342 1364 1371 1387 1388 1407 1412 1417 1423 1442
1457 1476 1479]
If a source was not extracted for a given extension, the values will be filled in with a value of “0” or “nan”. The column N_ALONGDISP
is a useful tracer for finding sources that were not extracted as it represents the number of pixels in the trace along the dispersion direction, so if it is zero, no pixels were used.
# looking at extension 1 (first file) as an example of what a source looks like if it's not extracted
ext = 1
wh_no_source = np.where(sample_x1d[ext].data['N_ALONGDISP'] == 0)[0]
if len(wh_no_source) > 0:
print(f"{sample_x1d[ext].header['FILENAME']} does not extract the following sources:")
print(f" {sample_x1d[ext].data['SOURCE_ID'][wh_no_source]}")
print("Different column defaults when a source is not extracted:")
for colname in sample_x1d[ext].data.names:
print(f" {colname} : {np.unique(sample_x1d[ext].data[colname][wh_no_source[0]])}")
jw02079004003_05101_00001_nis_cal.fits does not extract the following sources:
[124]
Different column defaults when a source is not extracted:
SOURCE_ID : [124]
WAVELENGTH : [nan]
FLUX : [nan]
FLUX_ERROR : [nan]
FLUX_VAR_POISSON : [nan]
FLUX_VAR_RNOISE : [nan]
FLUX_VAR_FLAT : [nan]
SURF_BRIGHT : [nan]
SB_ERROR : [nan]
SB_VAR_POISSON : [nan]
SB_VAR_RNOISE : [nan]
SB_VAR_FLAT : [nan]
DQ : [1]
BACKGROUND : [nan]
BKGD_ERROR : [nan]
BKGD_VAR_POISSON : [nan]
BKGD_VAR_RNOISE : [nan]
BKGD_VAR_FLAT : [nan]
NPIXELS : [nan]
N_ALONGDISP : [0]
SOURCE_TYPE : ['']
SOURCE_XPOS : [nan]
SOURCE_YPOS : [nan]
SOURCE_RA : [nan]
SOURCE_DEC : [nan]
EXTRACT2D_XSTART : [0]
EXTRACT2D_YSTART : [0]
EXTRACT2D_XSTOP : [0]
EXTRACT2D_YSTOP : [0]
Visualize Spec3 Outputs#
To compare with the Spec2 output products above, we look at the same sources, plotting instead the final *_c1d.fits
files for each grism. We again show the *_i2d.fits
image for a specific source, followed by the level 3 *_x1d.fits
individual spectra for each of the two grisms (if both were used–if one is not used that column will be blank), followed by the *_c1d.fits
combined spectrum for each of the grisms if available.
# looking at the i2d images, the level 3 x1d spectra, and the combined c1d spectra for both grisms for several sources
# this cell is grabbing the files & sources to look at
if doviz:
# grab the c1d files to plot
spec3_c1ds = np.sort(glob.glob(os.path.join(spec3_dir, "*c1d.fits")))
# If there are multiple pupils (blocking filters) pick one for illustration
unique_pupils = np.unique([fits.getval(c1d, 'PUPIL') for c1d in spec3_c1ds])
pupil_c1ds = [c1d for c1d in spec3_c1ds if fits.getval(c1d, 'PUPIL') == unique_pupils[0]]
if demo_mode:
# find the source catalog for this set of filters
source_catfile = os.path.join(image3_dir, fits.getval(pupil_x1ds[0], 'SCATFILE'))
# define some cool sources to look at if using the demo mode data
ra_decs = [(53.149299532671414, -27.788593590014425), # galaxy strong emission
(53.1490537204553, -27.774406172992315), # galaxy with contamination
(53.14917151184476, -27.79305522163517), # galaxy with contamination
(53.17659115324354, -27.785519434446663), # larger footprint galaxy
(53.158405995297684, -27.794984326598932)] # point source
sources = [find_closest_source_id(ra, dec, source_catfile) for ra, dec in ra_decs]
nsources = len(sources)
else:
# or grab some sources from the first x1d file
nsources = 5 # 100 sources are extracted by default
source_offset = 10 # offsetting what nsources to plot to avoid extra bright sources
with fits.open(pupil_c1ds[0]) as temp_c1d:
sources = temp_c1d[1].data['SOURCE_ID'][source_offset:nsources+source_offset]
# make sure you have run the cells defined convienence functions section: plot_i2d_plus_source & plot_spectrum
# this cell looks at the i2d images, the level 3 x1d spectra, and the combined c1d spectra for both grisms for several sources
if doviz:
# setting up the figure
cols = 4
rows = nsources
fig_c1d = plt.figure(figsize=(15, 4*(rows/2)))
# looping through the different sources to plot; one per row
for nsource, source_id in enumerate(sources):
# setting up the subplots for a single source
ypos = nsource
ax_i2d = plt.subplot2grid((rows, cols), (ypos, 0))
ax_x1d_r = plt.subplot2grid((rows, cols), (ypos, 1))
ax_x1d_c = plt.subplot2grid((rows, cols), (ypos, 2))
ax_c1d = plt.subplot2grid((rows, cols), (ypos, 3))
source_fluxes = [] # save the source flux to set the plot limits
# plot all of the 1-D combined spectra from the c1d files
for nfile, c1dfile in enumerate(pupil_c1ds):
# plotting the c1d spectra
ax_c1d, catname, source_fluxes, grism = plot_spectrum(c1dfile, source_fluxes, ax_c1d, image3_dir)
# plot the level 3 x1d files
x1dfile = c1dfile.replace('c1d', 'x1d')
with fits.open(x1dfile) as x1d:
for ext in range(len(x1d))[1:-1]:
if grism == 'GR150R':
ax_x1d_r, catname, source_fluxes, grism = plot_spectrum(x1dfile, source_fluxes, ax_x1d_r, image3_dir, ext=ext, legend=False)
else:
ax_x1d_c, catname, source_fluxes, grism = plot_spectrum(x1dfile, source_fluxes, ax_x1d_c, image3_dir, ext=ext, legend=False)
# plot the direct image of the source based on the source number from the source catalog
if nfile == 0:
ax_i2d = plot_i2d_plus_source(catname, source_id, ax_i2d)
# plot labels and such
if len(source_fluxes):
# there may not have been data to extract if everything was saturated
ax_c1d.set_ylim(np.nanmin(source_fluxes), np.nanmax(source_fluxes))
# Add labels to the subplots
if nsource == 0:
ax_i2d.set_title('Direct Image\n(i2d)')
ax_x1d_r.set_title('Individual GR150R 1-D Spectrum\n(level 3 x1d)')
ax_x1d_c.set_title('Individual GR150C 1-D Spectrum\n(level 3 x1d)')
ax_c1d.set_title('Combined 1-D Spectrum\n(c1d)')
ax_i2d.set_ylabel(f'Source\n{source_id}', fontsize=15)
for ax in [ax_x1d_r, ax_x1d_c, ax_c1d]:
ax.set_xlabel('Wavelength (microns)')
ax.set_ylabel('F_nu (Jy)')
ax.ticklabel_format(axis='y', style='sci', scilimits=(0, 0)) # forcing scientific notation for the spectra
fig_c1d.tight_layout()
fig_c1d.show()

