stsci_logo

NIRCam Imaging Pipeline Notebook#

Authors: B. Hilbert, based on the NIRISS imaging notebook by R. Diaz
Last Updated: July 16, 2025
Pipeline Version: 1.19.1 (Build 12.0)

Purpose:
This notebook provides a framework for processing generic Near-Infrared Camera (NIRCam) Imaging data through all three James Webb Space Telescope (JWST) pipeline stages. Data is assumed to be located in a folder structure following the 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.

Data:
This example is set up to use an example dataset is from Program ID 2739 (PI: Pontoppidan) which is a Cycle 1 Outreach program. We focus on the data from Observation 001 Visit 002, in which M-16, or the “Pillars of Creation” were observed. Example input data to use will be downloaded automatically unless disabled (i.e., to use local files instead).

JWST pipeline version and CRDS context:
This notebook was written for the calibration pipeline version given above. It sets the CRDS context to the latest context in the JWST Calibration Reference Data System (CRDS) associated with that pipeline version. If you use different pipeline versions or CRDS context, please read the relevant release notes (here for pipeline, here for CRDS) for possibly relevant changes.

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:
Sept 5, 2024: original notebook created
Nov 11, 2024: Comment out line to set the context
Nov 18, 2024: Do not require both SW and LW user-provided data
November 22, 2024: Updates to workflow when skipping pipeline modules
January 31, 2025: Update to build 11.2, update JDAViz Links Control to Orientation call
February 25, 2025: Add optional call to clean_flicker_noise
April 02, 2025: Update JDAviz call to work with JDAviz 4.2.1
May 5, 2025: Updated to jwst 1.18.0 (no significant changes)
July 16, 2025: Updated to jwst 1.19.1 (no significant changes)


Table of Contents#

  1. Configuration

  2. Package Imports

  3. Demo Mode Setup (ignore if not using demo data)

  4. Directory Setup

  5. Detector1 Pipeline

  6. Image2 Pipeline

  7. Image3 Pipeline

  8. Visualize the resampled images

  9. Visualize Detected Sources

  10. Notes


1. Configuration#


Set basic configuration for runing 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 nircam_imaging_pipeline python=3.11
conda activate nircam_imaging_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), and pipeline modules run in this data. The list of parameters are:

  • demo_mode

  • directories with data

  • pipeline modules

# Basic import necessary for configuration
import os
Note that demo_mode must be set appropriately below.

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 it through the pipeline. This will all happen in a local directory unless modified in Section 3 below.

Set demo_mode = False if you want to process your own data that has already been downloaded and provide the location of the data.

# Set parameters for demo_mode, channel, band, data mode directories, and 
# processing steps.

# -----------------------------Demo Mode---------------------------------
demo_mode = True

if demo_mode:
    print('Running in demonstration mode using online example data!')

# --------------------------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
    sci_dir = os.path.join(user_home_dir, 'PID2739/Obs001/')

# --------------------------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.

# Science processing
dodet1 = True  # calwebb_detector1
doimage2 = True  # calwebb_image2
doimage3 = True  # calwebb_image3
Running in demonstration mode using online example data!

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.

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----------------------

# Each version of the calibration pipeline is associated with a specific CRDS
# context file. The pipeline will select the appropriate context file behind
# the scenes while running. However, if you wish to override the default context
# file and run the pipeline with a different context, you can set that using
# the CRDS_CONTEXT environment variable. Here we show how this is done,
# although we leave the line commented out in order to use the default context.
# If you wish to specify a different context, uncomment the line below.
#%env CRDS_CONTEXT jwst_1293.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']}")
if os.getenv('CRDS_CONTEXT'):
    print(f"CRDS CONTEXT: {os.environ['CRDS_CONTEXT']}")
CRDS local filepath: /home/runner/crds
CRDS file server: https://jwst-crds.stsci.edu

2. Package Imports#

# Use the entire available screen width for this notebook
from IPython.display import display, HTML
display(HTML("<style>.container { width:95% !important; }</style>"))
# Basic system utilities for interacting with files
# ----------------------General Imports------------------------------------
import glob
import time
from pathlib import Path

# Numpy for doing calculations
import numpy as np

# To display full ouptut of cell, not just the last result
from IPython.core.interactiveshell import InteractiveShell
InteractiveShell.ast_node_interactivity = "all"

# -----------------------Astroquery Imports--------------------------------
# ASCII files, and downloading demo files
from astroquery.mast import Observations

# Astropy routines for visualizing detected sources:
from astropy.table import Table
from astropy.coordinates import SkyCoord

# ------------ Pipeline and  Visualization Imports -----------------------

# for JWST calibration pipeline
import jwst
import crds

from jwst.pipeline import Detector1Pipeline
from jwst.pipeline import Image2Pipeline
from jwst.pipeline import Image3Pipeline

# JWST pipeline utilities
from asdf import AsdfFile
from jwst import datamodels
from jwst.associations import asn_from_list  # Tools for creating association files
from jwst.associations.lib.rules_level3_base import DMS_Level3_Base  # Definition of a Lvl3 association file

# For visualizing images
from jdaviz import Imviz

# 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
# Start a timer to keep track of runtime
time0 = time.perf_counter()

3. Demo Mode Setup (ignore if not using demo data)#


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 using the NIRCam F200W and F444W filters and start with uncalibrated data products. The files are named jw02739001002_02105_0000<dither>_nrc<det>_uncal.fits, where dither refers to the dither step number, and det is the detector name. Through this notebook we will refer to data with filter F200W as SW data and F444W as LW data.

More information about the JWST file naming conventions can be found at: https://jwst-pipeline.readthedocs.io/en/latest/jwst/data_products/file_naming.html

# Set up the program information and paths for demo program
if demo_mode:
    print('Running in demonstration mode and will download example data from MAST!')
    program = "02739"
    sci_observtn = "001"
    
    data_dir = os.path.join('.', 'nrc_im_demo_data')
    download_dir = data_dir
    sci_dir = os.path.join(data_dir, 'Obs' + sci_observtn)
    uncal_dir = os.path.join(sci_dir, 'uncal')

    # Ensure filepaths for input data exist
    if not os.path.exists(uncal_dir):
        os.makedirs(uncal_dir)
        
    # Create directory if it does not exist
    if not os.path.isdir(data_dir):
        os.mkdir(data_dir)
Running in demonstration mode and will download example data from MAST!

Identify list of science (SCI) uncalibrated files associated with visits.

Work one filter at a time, so that we can more easily filter by detector and keep only the module A files.

First download the F200W data.

# Obtain a list of observation IDs for the specified demo program
if demo_mode:
    # Science data
    sci_obs_id_table = Observations.query_criteria(instrument_name=["NIRCAM/IMAGE"],
                                                   provenance_name=["CALJWST"],  # Executed observations
                                                   filters=['F200W'],  # Data for Specific Filter
                                                   obs_id=['jw' + program + '-o' + sci_observtn + '*']
                                                   )
if demo_mode:
    sci_obs_id_table
Table masked=True length=1
intentTypeobs_collectionprovenance_nameinstrument_nameprojectfilterswavelength_regiontarget_nametarget_classificationobs_ids_ras_decdataproduct_typeproposal_picalib_levelt_mint_maxt_exptimeem_minem_maxobs_titlet_obs_releaseproposal_idproposal_typesequence_numbers_regionjpegURLdataURLdataRightsmtFlagsrcDenobsidobjID
str7str4str7str12str4str5str8str4str42str36float64float64str5str21int64float64float64float64float64float64str30float64str4str2int64str117str62str63str6boolfloat64str9str9
scienceJWSTCALJWSTNIRCAM/IMAGEJWSTF200WINFRAREDM-16ISM; Molecular clouds; Nebulae; Protostarsjw02739-o001_t001_nircam_clear-f200w274.72990744573474-13.851719782834543imagePontoppidan, Klaus M.359805.4033750578759824.937561909723221.04000000000041755.02226.0JWST Cycle 1 Outreach Campaign59871.559826262739DD--POLYGON 274.693606027 -13.788468622 274.770277859 -13.79084972 274.766201619 -13.91520499 274.689488785 -13.912822617mast:JWST/product/jw02739-o001_t001_nircam_clear-f200w_i2d.jpgmast:JWST/product/jw02739-o001_t001_nircam_clear-f200w_i2d.fitsPUBLICFalsenan219392596819449804
# Turn the list of visits into a list of uncalibrated data files
if demo_mode:
    # Define types of files to select
    file_dict = {'uncal': {'product_type': 'SCIENCE',
                           'productSubGroupDescription': 'UNCAL',
                           'calib_level': [1]}}

    # Science files
    sci_files_to_download = []
    # Loop over visits identifying uncalibrated files that are associated
    # with them
    for exposure in (sci_obs_id_table):
        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'])

    # To limit data volume, keep only files from visit 002, dithers 1 and 2, and only A-module
    sw_sci_files_to_download = [fname for fname in sci_files_to_download if 'jw02739001002_02105' in fname and 
                                ('nrca2' in fname or 'nrca4' in fname) and ('00001' in fname or '00002' in fname)]
    sw_sci_files_to_download = sorted(sw_sci_files_to_download)
    print(f"Science files selected for downloading: {len(sw_sci_files_to_download)}")
Science files selected for downloading: 4
# List the SW files to download
if demo_mode:
    sw_sci_files_to_download
[np.str_('mast:JWST/product/jw02739001002_02105_00001_nrca2_uncal.fits'),
 np.str_('mast:JWST/product/jw02739001002_02105_00001_nrca4_uncal.fits'),
 np.str_('mast:JWST/product/jw02739001002_02105_00002_nrca2_uncal.fits'),
 np.str_('mast:JWST/product/jw02739001002_02105_00002_nrca4_uncal.fits')]

Now repeat the process for the F444W data.

# Obtain a list of observation IDs for the specified demo program
if demo_mode:
    # Science data
    sci_obs_id_table = Observations.query_criteria(instrument_name=["NIRCAM/IMAGE"],
                                                   provenance_name=["CALJWST"],  # Executed observations
                                                   filters=['F444W'],  # Data for Specific Filter
                                                   obs_id=['jw' + program + '-o' + sci_observtn + '*']
                                                   )
if demo_mode:
    sci_obs_id_table
Table masked=True length=2
intentTypeobs_collectionprovenance_nameinstrument_nameprojectfilterswavelength_regiontarget_nametarget_classificationobs_ids_ras_decdataproduct_typeproposal_picalib_levelt_mint_maxt_exptimeem_minem_maxobs_titlet_obs_releaseproposal_idproposal_typesequence_numbers_regionjpegURLdataURLdataRightsmtFlagsrcDenobsidobjID
str7str4str7str12str4str11str8str4str42str36float64float64str5str21int64float64float64float64float64float64str30float64str4str2int64str118str62str63str6boolfloat64str8str9
scienceJWSTCALJWSTNIRCAM/IMAGEJWSTF444W;F470NINFRAREDM-16ISM; Molecular clouds; Nebulae; Protostarsjw02739-o001_t001_nircam_f444w-f470n274.7299074457283-13.851719782779583imagePontoppidan, Klaus M.359805.3567742592659824.897919722225797.863880.04986.0JWST Cycle 1 Outreach Campaign59871.559826262739DD--POLYGON 274.694902514 -13.788681604 274.770064825 -13.791634646 274.764945806 -13.91493694 274.689743665 -13.911982331mast:JWST/product/jw02739-o001_t001_nircam_f444w-f470n_i2d.jpgmast:JWST/product/jw02739-o001_t001_nircam_f444w-f470n_i2d.fitsPUBLICFalsenan89121540819449696
scienceJWSTCALJWSTNIRCAM/IMAGEJWSTF444WINFRAREDM-16ISM; Molecular clouds; Nebulae; Protostarsjw02739-o001_t001_nircam_clear-f444w274.72990744573474-13.851719782834543imagePontoppidan, Klaus M.359805.4033757986159824.937561909723221.04000000000043880.04986.0JWST Cycle 1 Outreach Campaign59871.559826262739DD--POLYGON 274.694944698 -13.78865533 274.770038238 -13.791606754 274.764915198 -13.914959988 274.689781848 -13.912006997mast:JWST/product/jw02739-o001_t001_nircam_clear-f444w_i2d.jpgmast:JWST/product/jw02739-o001_t001_nircam_clear-f444w_i2d.fitsPUBLICFalsenan89121644819449855
# Turn the list of visits into a list of uncalibrated data files
if demo_mode:
    # Define types of files to select
    file_dict = {'uncal': {'product_type': 'SCIENCE',
                           'productSubGroupDescription': 'UNCAL',
                           'calib_level': [1]}}

    # Science files
    sci_files_to_download = []
    # Loop over visits identifying uncalibrated files that are associated
    # with them
    for exposure in (sci_obs_id_table):
        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'])

    # To limit data volume, keep only files from visit 002, dithers 1 and 2, and only A-module
    lw_sci_files_to_download = [fname for fname in sci_files_to_download if 'jw02739001002_02105' in fname and 
                                'nrca' in fname and ('00001' in fname or '00002' in fname)]
    lw_sci_files_to_download = sorted(lw_sci_files_to_download)
    print(f"Science files selected for downloading: {len(lw_sci_files_to_download)}")
Science files selected for downloading: 2
# List the LW files to download
if demo_mode:
    lw_sci_files_to_download
[np.str_('mast:JWST/product/jw02739001002_02105_00001_nrcalong_uncal.fits'),
 np.str_('mast:JWST/product/jw02739001002_02105_00002_nrcalong_uncal.fits')]
# Full list the science files to download
if demo_mode:
    sci_files_to_download = sw_sci_files_to_download + lw_sci_files_to_download
    sci_files_to_download
[np.str_('mast:JWST/product/jw02739001002_02105_00001_nrca2_uncal.fits'),
 np.str_('mast:JWST/product/jw02739001002_02105_00001_nrca4_uncal.fits'),
 np.str_('mast:JWST/product/jw02739001002_02105_00002_nrca2_uncal.fits'),
 np.str_('mast:JWST/product/jw02739001002_02105_00002_nrca4_uncal.fits'),
 np.str_('mast:JWST/product/jw02739001002_02105_00001_nrcalong_uncal.fits'),
 np.str_('mast:JWST/product/jw02739001002_02105_00002_nrcalong_uncal.fits')]

Download all the uncal files and place them into the appropriate directories.

Warning: If this notebook is halted during this step the downloaded file may be incomplete, and cause crashes later on!
# Download the demo data if it does not already exist
if demo_mode:
    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/jw02739001002_02105_00001_nrca2_uncal.fits to ./nrc_im_demo_data/Obs001/uncal/jw02739001002_02105_00001_nrca2_uncal.fits ...
 [Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:JWST/product/jw02739001002_02105_00001_nrca4_uncal.fits to ./nrc_im_demo_data/Obs001/uncal/jw02739001002_02105_00001_nrca4_uncal.fits ...
 [Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:JWST/product/jw02739001002_02105_00002_nrca2_uncal.fits to ./nrc_im_demo_data/Obs001/uncal/jw02739001002_02105_00002_nrca2_uncal.fits ...
 [Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:JWST/product/jw02739001002_02105_00002_nrca4_uncal.fits to ./nrc_im_demo_data/Obs001/uncal/jw02739001002_02105_00002_nrca4_uncal.fits ...
 [Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:JWST/product/jw02739001002_02105_00001_nrcalong_uncal.fits to ./nrc_im_demo_data/Obs001/uncal/jw02739001002_02105_00001_nrcalong_uncal.fits ...
 [Done]
Downloading URL https://mast.stsci.edu/api/v0.1/Download/file?uri=mast:JWST/product/jw02739001002_02105_00002_nrcalong_uncal.fits to ./nrc_im_demo_data/Obs001/uncal/jw02739001002_02105_00002_nrcalong_uncal.fits ...
 [Done]

4. 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')  # calwebb_spec2 pipeline outputs will go here
image3_dir = os.path.join(sci_dir, 'stage3')  # calwebb_spec3 pipeline outputs will go here

# We need to check that the desired output directories exist, and if not
# create them
if not os.path.exists(det1_dir):
    os.makedirs(det1_dir)
if not os.path.exists(image2_dir):
    os.makedirs(image2_dir)
if not os.path.exists(image3_dir):
    os.makedirs(image3_dir)

Look at the first file to determine exposure parameters and practice using JWST datamodels¶

# List uncal files
uncal_files = sorted(glob.glob(os.path.join(uncal_dir, '*_uncal.fits')))
    
# Separate SW from LW files
sw_uncal_files = [uncfile for uncfile in uncal_files if 'long' not in uncfile]
lw_uncal_files = [uncfile for uncfile in uncal_files if 'long' in uncfile]

colnames = ('Instrument', 'Filter', 'Pupil', 'Number of Integrations', 'Number of Groups',
            'Readout pattern', 'Dither position number')
dtypes = ('S7', 'S10', 'S10', 'i4', 'i4', 'S15', 'i4')
meta_check = Table(names=(colnames), dtype=dtypes)

# Open example files and get metadata for display
if len(sw_uncal_files) > 0:
    sw_examine = datamodels.open(sw_uncal_files[0])
    sw_row = [sw_examine.meta.instrument.name, sw_examine.meta.instrument.filter,
              sw_examine.meta.instrument.pupil, sw_examine.meta.exposure.nints,
              sw_examine.meta.exposure.ngroups, sw_examine.meta.exposure.readpatt,
              sw_examine.meta.dither.position_number]
    meta_check.add_row(sw_row)

if len(lw_uncal_files) > 0:
    lw_examine = datamodels.open(lw_uncal_files[0])
    lw_row = [lw_examine.meta.instrument.name, lw_examine.meta.instrument.filter,
              lw_examine.meta.instrument.pupil, lw_examine.meta.exposure.nints,
              lw_examine.meta.exposure.ngroups, lw_examine.meta.exposure.readpatt,
              lw_examine.meta.dither.position_number]
    meta_check.add_row(lw_row)

# Print out exposure info
meta_check
Table length=2
InstrumentFilterPupilNumber of IntegrationsNumber of GroupsReadout patternDither position number
bytes7bytes10bytes10int32int32bytes15int32
NIRCAMF200WCLEAR18BRIGHT11
NIRCAMF444WCLEAR18BRIGHT11

The table above shows basic exposure information from the first shortwave as well as the first longwave file. When using the demo data, we confirm that the data file is for the NIRCam instrument using the F200W and F444W filters in the Filter Wheel crossed with the CLEAR filter in the Pupil Wheel. This observation uses the BRIGHT1 readout pattern, 8 groups per integration, and 1 integration per exposure. This data file is the 1st dither position in this exposure sequence. For more information about how JWST exposures are defined by up-the-ramp sampling, see the Understanding Exposure Times JDox article.

This metadata will be the same for all exposures in this observation, except for the dither position number.

# Print out the time benchmark
time_det1 = time.perf_counter()
print(f"Runtime so far: {time_det1 - time0:0.0f} seconds")
Runtime so far: 15 seconds

5. Detector1 Pipeline#

Run the datasets through the Detector1 stage of the pipeline to apply detector level calibrations and create a countrate data product where slopes are fitted 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.

By default, all steps in the Detector1 stage of the pipeline are run for NIRCam except the ipc correction step and the gain_scale step. Note that the persistence step has been turned off by default starting with CRDS context jwst_1264.pmap. This step does not automatically correct the science data for persistence. The persistence step creates a *_trapsfilled.fits file which is a model that records the number of traps filled at each pixel at the end of an exposure. This file would be used as an input to the persistence step, via the input_trapsfilled argument, to correct the subsequent science exposure for persistence. Since persistence is not well calibrated for NIRCam, the step has been turned off in order to speed up calibration and to not create empty *_trapsfilled.fits files. This step can be turned on when running the pipeline in Python by doing:

rate_result = Detector1Pipeline.call(uncal, steps={'persistence': {'skip': False}})

or as indicated in the cell bellow using a dictionary.

As of CRDS context jwst_1155.pmap and later, the jump step of the Detector1 stage of the pipeline will remove signal associated with snowballs in the NIRCam imaging mode. This correction is turned on using the parameter expand_large_events=True. This and other parameters related to the snowball correction are specified in the pars-jumpstep parameter reference file. Users may wish to alter parameters to optimize removal of snowball residuals. Available parameters are discussed in the Detection and Flagging of Showers and Snowballs in JWST Technical Report (Regan 2023).

# Set up a dictionary to define how the Detector1 pipeline should be configured

# Boilerplate dictionary setup
det1dict = {}
det1dict['group_scale'], det1dict['dq_init'], det1dict['saturation'] = {}, {}, {}
det1dict['ipc'], det1dict['superbias'], det1dict['refpix'] = {}, {}, {}
det1dict['linearity'], det1dict['persistence'], det1dict['dark_current'], = {}, {}, {}
det1dict['charge_migration'], det1dict['jump'], det1dict['clean_flicker_noise'] = {}, {}, {}
det1dict['ramp_fit'], det1dict['gain_scale'] = {}, {}

# Overrides for whether or not certain steps should be skipped
# skipping the persistence step
det1dict['persistence']['skip'] = True

# 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['reset']['override_reset'] = 'myfile.fits'  # Reset
#det1dict['linearity']['override_linearity'] = 'myfile.fits'  # Linearity
#det1dict['rscd']['override_rscd'] = 'myfile.fits'  # RSCD
#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

# Turn on multi-core processing (This is off by default). Choose what fraction
# of cores to use (quarter, half, all, or an integer number)
det1dict['jump']['maximum_cores'] = 'half'

# Explicitly turn on snowball correction. (Even though it is on by default)
det1dict['jump']['expand_large_events'] = True

# Turn on 1/f correction if desired
# For guidance see https://jwst-docs.stsci.edu/known-issues-with-jwst-data/1-f-noise
#det1dict['clean_flicker_noise']['skip'] = False
#det1dict['clean_flicker_noise']['fit_method'] = 'median' # 'median' or 'fft'
#det1dict['clean_flicker_noise']['background_method'] = 'median' # 'median' or 'model'
#det1dict['clean_flicker_noise']['fit_by_channel'] = False

Run the Detector1 pipeline on all input data, regardless of filter.

# Run Detector1 stage of pipeline, specifying:
# output directory to save *_rate.fits files
# save_results flag set to True so the rate files are saved
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 12:47:53,418 - 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 12:47:53,532 - 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 12:47:53,673 - 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 12:47:53,826 - 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 12:47:53,880 - 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 12:47:53,930 - 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 12:47:53,970 - 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 12:47:54,076 - 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 12:47:54,113 - 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 12:47:54,165 - 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 12:47:54,198 - 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 12:47:54,232 - 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 12:47:54,365 - 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 12:47:54,406 - 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 12:47:54,439 - 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 12:47:54,472 - 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 12:47:54,506 - 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 12:47:54,668 - 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 12:47:54,813 - 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 12:47:54,860 - 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 12:47:54,899 - 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 12:47:54,942 - 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 12:47:55,069 - 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 12:47:55,180 - 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 12:47:55,284 - 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 12:47:55,322 - 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 12:47:55,352 - 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 12:47:55,384 - 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 12:47:55,422 - 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 12:47:55,536 - 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 12:47:55,567 - 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 12:47:55,598 - 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 12:47:55,638 - 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 12:47:55,673 - 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 12:47:55,706 - 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 12:47:55,742 - 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 12:47:55,781 - 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 12:47:55,963 - 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 12:47:55,999 - 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 12:47:56,032 - 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 12:47:56,063 - 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 12:47:56,097 - 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 12:47:56,141 - 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 12:47:56,179 - 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 12:47:56,292 - 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 12:47:56,326 - 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 12:47:56,357 - 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 12:47:56,470 - 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 12:47:56,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 12:47:56,538 - 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 12:47:56,572 - 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 12:47:56,604 - 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 12:47:56,637 - 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 12:47:56,671 - 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 12:47:56,708 - 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 12:47:56,744 - 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 12:47:56,883 - 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 12:47:56,929 - 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 12:47:56,962 - 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 12:47:56,995 - 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 12:47:57,026 - 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 12:47:57,057 - 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 12:47:57,092 - 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 12:47:57,124 - 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 12:47:57,156 - 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 12:47:57,186 - 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 12:47:57,225 - 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 12:47:57,259 - 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 12:47:57,291 - 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 12:47:57,329 - 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 12:47:57,370 - 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 12:47:57,399 - 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 12:47:57,429 - 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 12:47:57,464 - 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 12:47:57,495 - 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 12:47:57,524 - 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 12:47:57,555 - 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 12:47:57,589 - 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 12:47:57,620 - 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 12:47:57,651 - 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 12:47:57,693 - 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 12:47:57,731 - 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 12:47:57,763 - 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 12:47:57,797 - 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 12:47:57,832 - 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 12:47:57,867 - 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 12:47:57,899 - 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 12:47:57,938 - 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 12:47:57,970 - 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 12:47:58,001 - 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 12:47:58,033 - 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 12:47:58,066 - 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 12:47:58,095 - 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 12:47:58,164 - 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 12:47:58,204 - 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 12:47:58,234 - 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 12:47:58,267 - 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 12:47:58,298 - 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 12:47:58,328 - 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 12:47:58,365 - 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 12:47:58,395 - 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 12:47:58,432 - 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 12:47:58,465 - 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 12:47:58,504 - 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 12:47:58,547 - 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 12:47:58,586 - 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 12:47:58,616 - 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 12:47:58,648 - 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 12:47:58,680 - 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 12:47:58,710 - 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 12:47:58,742 - 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 12:47:58,778 - 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 12:47:58,811 - 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 12:47:58,849 - 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 12:47:58,881 - 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 12:47:58,911 - 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 12:47:58,947 - 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 12:47:58,978 - 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 12:47:59,038 - 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 12:47:59,072 - 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 12:47:59,101 - 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 12:47:59,143 - 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 12:47:59,192 - 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 12:47:59,224 - 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 12:47:59,265 - 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 12:47:59,300 - 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 12:47:59,360 - 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 12:47:59,400 - 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 12:47:59,438 - 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 12:47:59,475 - 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 12:47:59,509 - 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 12:47:59,540 - 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 12:47:59,576 - 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 12:47:59,607 - 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 12:47:59,637 - 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 12:47:59,669 - 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 12:47:59,702 - 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 12:47:59,732 - 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 12:47:59,772 - 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 12:47:59,806 - 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 12:47:59,837 - 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 12:47:59,868 - 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 12:47:59,900 - 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 12:47:59,932 - 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 12:47:59,967 - 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 12:48:00,008 - 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 12:48:00,041 - 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 12:48:00,075 - 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 12:48:00,109 - 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 12:48:00,153 - 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 12:48:00,201 - 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 12:48:00,233 - 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 12:48:00,273 - 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 12:48:00,305 - 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 12:48:00,339 - 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 12:48:00,377 - 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 12:48:00,410 - 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 12:48:00,441 - 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 12:48:00,480 - 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 12:48:00,512 - 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 12:48:00,543 - 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 12:48:00,576 - 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 12:48:00,607 - 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 12:48:00,638 - 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 12:48:00,669 - 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 12:48:00,703 - 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 12:48:00,737 - 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 12:48:00,772 - 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 12:48:00,803 - 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 12:48:00,834 - 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 12:48:00,867 - 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 12:48:00,897 - 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 12:48:00,928 - 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 12:48:00,959 - 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 12:48:00,990 - 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 12:48:01,023 - 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 12:48:01,054 - 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 12:48:01,094 - 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 12:48:01,126 - 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 12:48:01,169 - 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 12:48:01,200 - 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 12:48:01,238 - 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 12:48:01,269 - 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 12:48:01,305 - 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 12:48:01,337 - 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 12:48:01,373 - 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 12:48:01,406 - 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 12:48:01,441 - 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 12:48:01,473 - 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 12:48:01,504 - 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 12:48:01,533 - 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 12:48:01,565 - 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 12:48:01,598 - 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 12:48:01,638 - 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 12:48:01,672 - 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 12:48:01,705 - 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 12:48:01,740 - 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 12:48:01,781 - 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 12:48:01,823 - 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 12:48:01,856 - 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 12:48:01,891 - 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 12:48:01,923 - 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 12:48:01,958 - 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 12:48:01,990 - 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 12:48:02,024 - 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 12:48:02,056 - 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 12:48:02,582 - CRDS - ERROR -  Error determining best reference for 'pars-darkcurrentstep'  =   No match found.
2025-09-13 12:48:02,588 - CRDS - INFO -  Fetching  /home/runner/crds/references/jwst/nircam/jwst_nircam_pars-jumpstep_0003.asdf    1.8 K bytes  (1 / 1 files) (0 / 1.8 K bytes)
2025-09-13 12:48:02,622 - stpipe - INFO - PARS-JUMPSTEP parameters found: /home/runner/crds/references/jwst/nircam/jwst_nircam_pars-jumpstep_0003.asdf
2025-09-13 12:48:02,637 - CRDS - INFO -  Fetching  /home/runner/crds/references/jwst/nircam/jwst_nircam_pars-detector1pipeline_0005.asdf    2.1 K bytes  (1 / 1 files) (0 / 2.1 K bytes)
2025-09-13 12:48:02,679 - stpipe - INFO - PARS-DETECTOR1PIPELINE parameters found: /home/runner/crds/references/jwst/nircam/jwst_nircam_pars-detector1pipeline_0005.asdf
2025-09-13 12:48:02,696 - stpipe.Detector1Pipeline - INFO - Detector1Pipeline instance created.
2025-09-13 12:48:02,697 - stpipe.Detector1Pipeline.group_scale - INFO - GroupScaleStep instance created.
2025-09-13 12:48:02,699 - stpipe.Detector1Pipeline.dq_init - INFO - DQInitStep instance created.
2025-09-13 12:48:02,700 - stpipe.Detector1Pipeline.emicorr - INFO - EmiCorrStep instance created.
2025-09-13 12:48:02,701 - stpipe.Detector1Pipeline.saturation - INFO - SaturationStep instance created.
2025-09-13 12:48:02,702 - stpipe.Detector1Pipeline.ipc - INFO - IPCStep instance created.
2025-09-13 12:48:02,703 - stpipe.Detector1Pipeline.superbias - INFO - SuperBiasStep instance created.
2025-09-13 12:48:02,704 - stpipe.Detector1Pipeline.refpix - INFO - RefPixStep instance created.
2025-09-13 12:48:02,705 - stpipe.Detector1Pipeline.rscd - INFO - RscdStep instance created.
2025-09-13 12:48:02,705 - stpipe.Detector1Pipeline.firstframe - INFO - FirstFrameStep instance created.
2025-09-13 12:48:02,706 - stpipe.Detector1Pipeline.lastframe - INFO - LastFrameStep instance created.
2025-09-13 12:48:02,707 - stpipe.Detector1Pipeline.linearity - INFO - LinearityStep instance created.
2025-09-13 12:48:02,708 - stpipe.Detector1Pipeline.dark_current - INFO - DarkCurrentStep instance created.
2025-09-13 12:48:02,709 - stpipe.Detector1Pipeline.reset - INFO - ResetStep instance created.
2025-09-13 12:48:02,710 - stpipe.Detector1Pipeline.persistence - INFO - PersistenceStep instance created.
2025-09-13 12:48:02,711 - stpipe.Detector1Pipeline.charge_migration - INFO - ChargeMigrationStep instance created.
2025-09-13 12:48:02,713 - stpipe.Detector1Pipeline.jump - INFO - JumpStep instance created.
2025-09-13 12:48:02,714 - stpipe.Detector1Pipeline.clean_flicker_noise - INFO - CleanFlickerNoiseStep instance created.
2025-09-13 12:48:02,715 - stpipe.Detector1Pipeline.ramp_fit - INFO - RampFitStep instance created.
2025-09-13 12:48:02,716 - stpipe.Detector1Pipeline.gain_scale - INFO - GainScaleStep instance created.
2025-09-13 12:48:02,913 - stpipe.Detector1Pipeline - INFO - Step Detector1Pipeline running with args ('./nrc_im_demo_data/Obs001/uncal/jw02739001002_02105_00001_nrca2_uncal.fits',).
2025-09-13 12:48:02,935 - stpipe.Detector1Pipeline - INFO - Step Detector1Pipeline parameters are:
  pre_hooks: []
  post_hooks: []
  output_file: None
  output_dir: ./nrc_im_demo_data/Obs001/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: sirs
      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: True
      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: True
      suffix: None
      search_output_file: True
      input_dir: ''
      signal_threshold: 25000.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: half
      flag_4_neighbors: True
      max_jump_to_flag_neighbors: 1000
      min_jump_to_flag_neighbors: 30
      after_jump_flag_dn1: 0
      after_jump_flag_time1: 0
      after_jump_flag_dn2: 0
      after_jump_flag_time2: 0
      expand_large_events: True
      min_sat_area: 1
      min_jump_area: 5
      expand_factor: 2
      use_ellipses: False
      sat_required_snowball: True
      min_sat_radius_extend: 2.5
      sat_expand: 2
      edge_size: 25
      mask_snowball_core_next_int: True
      snowball_time_masked_next_int: 4000
      find_showers: False
      max_shower_amplitude: 4.0
      extend_snr_threshold: 0.0
      extend_min_area: 0
      extend_inner_radius: 0
      extend_outer_radius: 0.0
      extend_ellipse_expand_ratio: 0.0
      time_masked_after_shower: 0
      min_diffs_single_pass: 10
      max_extended_radius: 200
      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 12:48:02,955 - stpipe.Detector1Pipeline - INFO - Prefetching reference files for dataset: 'jw02739001002_02105_00001_nrca2_uncal.fits' reftypes = ['dark', 'gain', 'linearity', 'mask', 'readnoise', 'refpix', 'reset', 'rscd', 'saturation', 'sirskernel', 'superbias']
2025-09-13 12:48:02,958 - CRDS - INFO -  Fetching  /home/runner/crds/references/jwst/nircam/jwst_nircam_dark_0342.fits    6.3 G bytes  (1 / 8 files) (0 / 6.6 G bytes)
2025-09-13 12:49:24,279 - CRDS - INFO -  Fetching  /home/runner/crds/references/jwst/nircam/jwst_nircam_gain_0093.fits   16.8 M bytes  (2 / 8 files) (6.3 G / 6.6 G bytes)
2025-09-13 12:49:24,468 - CRDS - INFO -  Fetching  /home/runner/crds/references/jwst/nircam/jwst_nircam_linearity_0051.fits  151.0 M bytes  (3 / 8 files) (6.3 G / 6.6 G bytes)
2025-09-13 12:49:26,404 - CRDS - INFO -  Fetching  /home/runner/crds/references/jwst/nircam/jwst_nircam_mask_0072.fits   16.8 M bytes  (4 / 8 files) (6.5 G / 6.6 G bytes)
2025-09-13 12:49:26,611 - CRDS - INFO -  Fetching  /home/runner/crds/references/jwst/nircam/jwst_nircam_readnoise_0224.fits   16.8 M bytes  (5 / 8 files) (6.5 G / 6.6 G bytes)
2025-09-13 12:49:26,928 - CRDS - INFO -  Fetching  /home/runner/crds/references/jwst/nircam/jwst_nircam_saturation_0104.fits   33.6 M bytes  (6 / 8 files) (6.5 G / 6.6 G bytes)
2025-09-13 12:49:27,369 - CRDS - INFO -  Fetching  /home/runner/crds/references/jwst/nircam/jwst_nircam_sirskernel_0002.asdf  661.0 K bytes  (7 / 8 files) (6.5 G / 6.6 G bytes)
2025-09-13 12:49:27,442 - CRDS - INFO -  Fetching  /home/runner/crds/references/jwst/nircam/jwst_nircam_superbias_0186.fits   50.4 M bytes  (8 / 8 files) (6.5 G / 6.6 G bytes)
2025-09-13 12:49:28,135 - stpipe.Detector1Pipeline - INFO - Prefetch for DARK reference file is '/home/runner/crds/references/jwst/nircam/jwst_nircam_dark_0342.fits'.
2025-09-13 12:49:28,136 - stpipe.Detector1Pipeline - INFO - Prefetch for GAIN reference file is '/home/runner/crds/references/jwst/nircam/jwst_nircam_gain_0093.fits'.
2025-09-13 12:49:28,137 - stpipe.Detector1Pipeline - INFO - Prefetch for LINEARITY reference file is '/home/runner/crds/references/jwst/nircam/jwst_nircam_linearity_0051.fits'.
2025-09-13 12:49:28,137 - stpipe.Detector1Pipeline - INFO - Prefetch for MASK reference file is '/home/runner/crds/references/jwst/nircam/jwst_nircam_mask_0072.fits'.
2025-09-13 12:49:28,138 - stpipe.Detector1Pipeline - INFO - Prefetch for READNOISE reference file is '/home/runner/crds/references/jwst/nircam/jwst_nircam_readnoise_0224.fits'.
2025-09-13 12:49:28,138 - stpipe.Detector1Pipeline - INFO - Prefetch for REFPIX reference file is 'N/A'.
2025-09-13 12:49:28,139 - stpipe.Detector1Pipeline - INFO - Prefetch for RESET reference file is 'N/A'.
2025-09-13 12:49:28,139 - stpipe.Detector1Pipeline - INFO - Prefetch for RSCD reference file is 'N/A'.
2025-09-13 12:49:28,139 - stpipe.Detector1Pipeline - INFO - Prefetch for SATURATION reference file is '/home/runner/crds/references/jwst/nircam/jwst_nircam_saturation_0104.fits'.
2025-09-13 12:49:28,140 - stpipe.Detector1Pipeline - INFO - Prefetch for SIRSKERNEL reference file is '/home/runner/crds/references/jwst/nircam/jwst_nircam_sirskernel_0002.asdf'.
2025-09-13 12:49:28,141 - stpipe.Detector1Pipeline - INFO - Prefetch for SUPERBIAS reference file is '/home/runner/crds/references/jwst/nircam/jwst_nircam_superbias_0186.fits'.
2025-09-13 12:49:28,141 - jwst.pipeline.calwebb_detector1 - INFO - Starting calwebb_detector1 ...
2025-09-13 12:49:28,516 - stpipe.Detector1Pipeline.group_scale - INFO - Step group_scale running with args (<RampModel(1, 8, 2048, 2048) from jw02739001002_02105_00001_nrca2_uncal.fits>,).
2025-09-13 12:49:28,523 - stpipe.Detector1Pipeline.group_scale - INFO - NFRAMES and FRMDIVSR are equal; correction not needed
2025-09-13 12:49:28,523 - stpipe.Detector1Pipeline.group_scale - INFO - Step will be skipped
2025-09-13 12:49:28,525 - stpipe.Detector1Pipeline.group_scale - INFO - Step group_scale done
2025-09-13 12:49:28,727 - stpipe.Detector1Pipeline.dq_init - INFO - Step dq_init running with args (<RampModel(1, 8, 2048, 2048) from jw02739001002_02105_00001_nrca2_uncal.fits>,).
2025-09-13 12:49:28,738 - stpipe.Detector1Pipeline.dq_init - INFO - Using MASK reference file /home/runner/crds/references/jwst/nircam/jwst_nircam_mask_0072.fits
2025-09-13 12:49:28,942 - 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 12:49:28,984 - stpipe.Detector1Pipeline.dq_init - INFO - Step dq_init done
2025-09-13 12:49:29,189 - stpipe.Detector1Pipeline.saturation - INFO - Step saturation running with args (<RampModel(1, 8, 2048, 2048) from jw02739001002_02105_00001_nrca2_uncal.fits>,).
2025-09-13 12:49:29,202 - stpipe.Detector1Pipeline.saturation - INFO - Using SATURATION reference file /home/runner/crds/references/jwst/nircam/jwst_nircam_saturation_0104.fits
2025-09-13 12:49:29,202 - stpipe.Detector1Pipeline.saturation - INFO - Using SUPERBIAS reference file /home/runner/crds/references/jwst/nircam/jwst_nircam_superbias_0186.fits
2025-09-13 12:49:29,252 - stdatamodels.dynamicdq - WARNING - Keyword RESERVED_4 does not correspond to an existing DQ mnemonic, so will be ignored
2025-09-13 12:49:29,303 - stdatamodels.dynamicdq - WARNING - Keyword UNRELIABLE_RESET does not correspond to an existing DQ mnemonic, so will be ignored
2025-09-13 12:49:29,468 - jwst.saturation.saturation - INFO - Using read_pattern with nframes 1
2025-09-13 12:49:29,840 - stcal.saturation.saturation - INFO - Detected 8870 saturated pixels
2025-09-13 12:49:29,858 - stcal.saturation.saturation - INFO - Detected 1 A/D floor pixels
2025-09-13 12:49:29,866 - stpipe.Detector1Pipeline.saturation - INFO - Step saturation done
2025-09-13 12:49:30,071 - stpipe.Detector1Pipeline.ipc - INFO - Step ipc running with args (<RampModel(1, 8, 2048, 2048) from jw02739001002_02105_00001_nrca2_uncal.fits>,).
2025-09-13 12:49:30,072 - stpipe.Detector1Pipeline.ipc - INFO - Step skipped.
2025-09-13 12:49:30,278 - stpipe.Detector1Pipeline.superbias - INFO - Step superbias running with args (<RampModel(1, 8, 2048, 2048) from jw02739001002_02105_00001_nrca2_uncal.fits>,).
2025-09-13 12:49:30,294 - stpipe.Detector1Pipeline.superbias - INFO - Using SUPERBIAS reference file /home/runner/crds/references/jwst/nircam/jwst_nircam_superbias_0186.fits
2025-09-13 12:49:30,528 - stpipe.Detector1Pipeline.superbias - INFO - Step superbias done
2025-09-13 12:49:30,733 - stpipe.Detector1Pipeline.refpix - INFO - Step refpix running with args (<RampModel(1, 8, 2048, 2048) from jw02739001002_02105_00001_nrca2_uncal.fits>,).
2025-09-13 12:49:30,762 - stpipe.Detector1Pipeline.refpix - INFO - Using SIRS reference file: /home/runner/crds/references/jwst/nircam/jwst_nircam_sirskernel_0002.asdf
2025-09-13 12:49:30,781 - jwst.refpix.reference_pixels - INFO - NIR full frame data
2025-09-13 12:49:30,781 - jwst.refpix.reference_pixels - INFO - The following parameters are valid for this mode:
2025-09-13 12:49:30,782 - jwst.refpix.reference_pixels - INFO - sigreject = 4.0
2025-09-13 12:49:30,783 - jwst.refpix.reference_pixels - INFO - gaussmooth = 1.0
2025-09-13 12:49:30,783 - jwst.refpix.reference_pixels - INFO - halfwidth = 30
2025-09-13 12:49:31,075 - stpipe.Detector1Pipeline.refpix - INFO - Step refpix done
2025-09-13 12:49:31,279 - stpipe.Detector1Pipeline.linearity - INFO - Step linearity running with args (<RampModel(1, 8, 2048, 2048) from jw02739001002_02105_00001_nrca2_uncal.fits>,).
2025-09-13 12:49:31,295 - stpipe.Detector1Pipeline.linearity - INFO - Using Linearity reference file /home/runner/crds/references/jwst/nircam/jwst_nircam_linearity_0051.fits
2025-09-13 12:49:31,359 - stdatamodels.dynamicdq - WARNING - Keyword UAZ_DO_NOT_USE does not correspond to an existing DQ mnemonic, so will be ignored
2025-09-13 12:49:31,360 - stdatamodels.dynamicdq - WARNING - Keyword UAZ_NO_LIN_SAMP does not correspond to an existing DQ mnemonic, so will be ignored
2025-09-13 12:49:31,361 - stdatamodels.dynamicdq - WARNING - Keyword UAZ_BAD_LIN_FIT does not correspond to an existing DQ mnemonic, so will be ignored
2025-09-13 12:49:31,361 - stdatamodels.dynamicdq - WARNING - Keyword UAZ_NO_WELL_SAMP does not correspond to an existing DQ mnemonic, so will be ignored
2025-09-13 12:49:31,362 - stdatamodels.dynamicdq - WARNING - Keyword UAZ_MODEL_FIT_FAIL does not correspond to an existing DQ mnemonic, so will be ignored
2025-09-13 12:49:31,362 - stdatamodels.dynamicdq - WARNING - Keyword UAZ_WELL_NOT_DEFINED does not correspond to an existing DQ mnemonic, so will be ignored
2025-09-13 12:49:31,363 - stdatamodels.dynamicdq - WARNING - Keyword UAZ_MASTER_MASK does not correspond to an existing DQ mnemonic, so will be ignored
2025-09-13 12:49:31,855 - stpipe.Detector1Pipeline.linearity - INFO - Step linearity done
2025-09-13 12:49:32,047 - stpipe.Detector1Pipeline.persistence - INFO - Step persistence running with args (<RampModel(1, 8, 2048, 2048) from jw02739001002_02105_00001_nrca2_uncal.fits>,).
2025-09-13 12:49:32,047 - stpipe.Detector1Pipeline.persistence - INFO - Step skipped.
2025-09-13 12:49:32,243 - stpipe.Detector1Pipeline.dark_current - INFO - Step dark_current running with args (<RampModel(1, 8, 2048, 2048) from jw02739001002_02105_00001_nrca2_uncal.fits>,).
2025-09-13 12:49:32,259 - stpipe.Detector1Pipeline.dark_current - INFO - Using DARK reference file /home/runner/crds/references/jwst/nircam/jwst_nircam_dark_0342.fits
2025-09-13 12:49:34,767 - stdatamodels.dynamicdq - WARNING - Keyword RESERVED_4 does not correspond to an existing DQ mnemonic, so will be ignored
2025-09-13 12:49:34,807 - stdatamodels.dynamicdq - WARNING - Keyword UNRELIABLE_RESET does not correspond to an existing DQ mnemonic, so will be ignored
2025-09-13 12:49:34,818 - stcal.dark_current.dark_sub - INFO - Science data nints=1, ngroups=8, nframes=1, groupgap=1
2025-09-13 12:49:34,819 - stcal.dark_current.dark_sub - INFO - Dark data nints=1, ngroups=187, nframes=1, groupgap=0
2025-09-13 12:49:35,763 - stpipe.Detector1Pipeline.dark_current - INFO - Step dark_current done
2025-09-13 12:49:36,035 - stpipe.Detector1Pipeline.charge_migration - INFO - Step charge_migration running with args (<RampModel(1, 8, 2048, 2048) from jw02739001002_02105_00001_nrca2_uncal.fits>,).
2025-09-13 12:49:36,035 - stpipe.Detector1Pipeline.charge_migration - INFO - Step skipped.
2025-09-13 12:49:36,234 - stpipe.Detector1Pipeline.jump - INFO - Step jump running with args (<RampModel(1, 8, 2048, 2048) from jw02739001002_02105_00001_nrca2_uncal.fits>,).
2025-09-13 12:49:36,241 - stpipe.Detector1Pipeline.jump - INFO - CR rejection threshold = 4 sigma
2025-09-13 12:49:36,242 - stpipe.Detector1Pipeline.jump - INFO - Maximum cores to use = half
2025-09-13 12:49:36,270 - stpipe.Detector1Pipeline.jump - INFO - Using GAIN reference file: /home/runner/crds/references/jwst/nircam/jwst_nircam_gain_0093.fits
2025-09-13 12:49:36,273 - stpipe.Detector1Pipeline.jump - INFO - Using READNOISE reference file: /home/runner/crds/references/jwst/nircam/jwst_nircam_readnoise_0224.fits
2025-09-13 12:49:36,400 - stcal.jump.jump - INFO - Executing two-point difference method
2025-09-13 12:49:36,400 - stcal.jump.jump - INFO - Creating 2 processes for jump detection 
2025-09-13 12:49:39,889 - stcal.jump.jump - INFO - Flagging Snowballs
2025-09-13 12:49:40,120 - stcal.jump.jump - INFO - Total snowballs = 62
2025-09-13 12:49:40,121 - stcal.jump.jump - INFO - Total elapsed time = 3.7207 sec
2025-09-13 12:49:40,159 - stpipe.Detector1Pipeline.jump - INFO - The execution time in seconds: 3.918065
2025-09-13 12:49:40,163 - stpipe.Detector1Pipeline.jump - INFO - Step jump done
2025-09-13 12:49:40,371 - stpipe.Detector1Pipeline.clean_flicker_noise - INFO - Step clean_flicker_noise running with args (<RampModel(1, 8, 2048, 2048) from jw02739001002_02105_00001_nrca2_uncal.fits>,).
2025-09-13 12:49:40,372 - stpipe.Detector1Pipeline.clean_flicker_noise - INFO - Step skipped.
2025-09-13 12:49:40,576 - stpipe.Detector1Pipeline.ramp_fit - INFO - Step ramp_fit running with args (<RampModel(1, 8, 2048, 2048) from jw02739001002_02105_00001_nrca2_uncal.fits>,).
2025-09-13 12:49:40,632 - jwst.ramp_fitting.ramp_fit_step - INFO - Using READNOISE reference file: /home/runner/crds/references/jwst/nircam/jwst_nircam_readnoise_0224.fits
2025-09-13 12:49:40,633 - jwst.ramp_fitting.ramp_fit_step - INFO - Using GAIN reference file: /home/runner/crds/references/jwst/nircam/jwst_nircam_gain_0093.fits
2025-09-13 12:49:40,658 - jwst.ramp_fitting.ramp_fit_step - INFO - Using algorithm = OLS_C
2025-09-13 12:49:40,659 - jwst.ramp_fitting.ramp_fit_step - INFO - Using weighting = optimal
2025-09-13 12:49:40,808 - stcal.ramp_fitting.ols_fit - INFO - Number of multiprocessing slices: 1
2025-09-13 12:49:43,422 - stcal.ramp_fitting.ols_fit - INFO - Ramp Fitting C Time: 2.6098222732543945
2025-09-13 12:49:43,473 - stpipe.Detector1Pipeline.ramp_fit - INFO - Step ramp_fit done
2025-09-13 12:49:43,671 - stpipe.Detector1Pipeline.gain_scale - INFO - Step gain_scale running with args (<ImageModel(2048, 2048) from jw02739001002_02105_00001_nrca2_uncal.fits>,).
2025-09-13 12:49:43,695 - stpipe.Detector1Pipeline.gain_scale - INFO - GAINFACT not found in gain reference file
2025-09-13 12:49:43,696 - stpipe.Detector1Pipeline.gain_scale - INFO - Step will be skipped
2025-09-13 12:49:43,698 - stpipe.Detector1Pipeline.gain_scale - INFO - Step gain_scale done
2025-09-13 12:49:43,887 - stpipe.Detector1Pipeline.gain_scale - INFO - Step gain_scale running with args (<CubeModel(1, 2048, 2048) from jw02739001002_02105_00001_nrca2_uncal.fits>,).
2025-09-13 12:49:43,907 - stpipe.Detector1Pipeline.gain_scale - INFO - GAINFACT not found in gain reference file
2025-09-13 12:49:43,907 - stpipe.Detector1Pipeline.gain_scale - INFO - Step will be skipped
2025-09-13 12:49:43,909 - stpipe.Detector1Pipeline.gain_scale - INFO - Step gain_scale done
2025-09-13 12:49:44,023 - stpipe.Detector1Pipeline - INFO - Saved model in ./nrc_im_demo_data/Obs001/stage1/jw02739001002_02105_00001_nrca2_rateints.fits
2025-09-13 12:49:44,024 - jwst.pipeline.calwebb_detector1 - INFO - ... ending calwebb_detector1
2025-09-13 12:49:44,026 - jwst.stpipe.core - INFO - Results used CRDS context: jwst_1413.pmap
2025-09-13 12:49:44,138 - stpipe.Detector1Pipeline - INFO - Saved model in ./nrc_im_demo_data/Obs001/stage1/jw02739001002_02105_00001_nrca2_rate.fits
2025-09-13 12:49:44,139 - stpipe.Detector1Pipeline - INFO - Step Detector1Pipeline done
2025-09-13 12:49:44,139 - jwst.stpipe.core - INFO - Results used jwst version: 1.19.1
2025-09-13 12:49:44,170 - CRDS - ERROR -  Error determining best reference for 'pars-darkcurrentstep'  =   No match found.
2025-09-13 12:49:44,174 - stpipe - INFO - PARS-JUMPSTEP parameters found: /home/runner/crds/references/jwst/nircam/jwst_nircam_pars-jumpstep_0003.asdf
2025-09-13 12:49:44,186 - stpipe - INFO - PARS-DETECTOR1PIPELINE parameters found: /home/runner/crds/references/jwst/nircam/jwst_nircam_pars-detector1pipeline_0005.asdf
2025-09-13 12:49:44,203 - stpipe.Detector1Pipeline - INFO - Detector1Pipeline instance created.
2025-09-13 12:49:44,203 - stpipe.Detector1Pipeline.group_scale - INFO - GroupScaleStep instance created.
2025-09-13 12:49:44,204 - stpipe.Detector1Pipeline.dq_init - INFO - DQInitStep instance created.
2025-09-13 12:49:44,205 - stpipe.Detector1Pipeline.emicorr - INFO - EmiCorrStep instance created.
2025-09-13 12:49:44,206 - stpipe.Detector1Pipeline.saturation - INFO - SaturationStep instance created.
2025-09-13 12:49:44,207 - stpipe.Detector1Pipeline.ipc - INFO - IPCStep instance created.
2025-09-13 12:49:44,208 - stpipe.Detector1Pipeline.superbias - INFO - SuperBiasStep instance created.
2025-09-13 12:49:44,209 - stpipe.Detector1Pipeline.refpix - INFO - RefPixStep instance created.
2025-09-13 12:49:44,211 - stpipe.Detector1Pipeline.rscd - INFO - RscdStep instance created.
2025-09-13 12:49:44,211 - stpipe.Detector1Pipeline.firstframe - INFO - FirstFrameStep instance created.
2025-09-13 12:49:44,212 - stpipe.Detector1Pipeline.lastframe - INFO - LastFrameStep instance created.
2025-09-13 12:49:44,213 - stpipe.Detector1Pipeline.linearity - INFO - LinearityStep instance created.
2025-09-13 12:49:44,214 - stpipe.Detector1Pipeline.dark_current - INFO - DarkCurrentStep instance created.
2025-09-13 12:49:44,215 - stpipe.Detector1Pipeline.reset - INFO - ResetStep instance created.
2025-09-13 12:49:44,215 - stpipe.Detector1Pipeline.persistence - INFO - PersistenceStep instance created.
2025-09-13 12:49:44,216 - stpipe.Detector1Pipeline.charge_migration - INFO - ChargeMigrationStep instance created.
2025-09-13 12:49:44,219 - stpipe.Detector1Pipeline.jump - INFO - JumpStep instance created.
2025-09-13 12:49:44,220 - stpipe.Detector1Pipeline.clean_flicker_noise - INFO - CleanFlickerNoiseStep instance created.
2025-09-13 12:49:44,221 - stpipe.Detector1Pipeline.ramp_fit - INFO - RampFitStep instance created.
2025-09-13 12:49:44,222 - stpipe.Detector1Pipeline.gain_scale - INFO - GainScaleStep instance created.
2025-09-13 12:49:44,423 - stpipe.Detector1Pipeline - INFO - Step Detector1Pipeline running with args ('./nrc_im_demo_data/Obs001/uncal/jw02739001002_02105_00001_nrca4_uncal.fits',).
2025-09-13 12:49:44,443 - stpipe.Detector1Pipeline - INFO - Step Detector1Pipeline parameters are:
  pre_hooks: []
  post_hooks: []
  output_file: None
  output_dir: ./nrc_im_demo_data/Obs001/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: sirs
      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: True
      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: True
      suffix: None
      search_output_file: True
      input_dir: ''
      signal_threshold: 25000.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: half
      flag_4_neighbors: True
      max_jump_to_flag_neighbors: 1000
      min_jump_to_flag_neighbors: 30
      after_jump_flag_dn1: 0
      after_jump_flag_time1: 0
      after_jump_flag_dn2: 0
      after_jump_flag_time2: 0
      expand_large_events: True
      min_sat_area: 1
      min_jump_area: 5
      expand_factor: 2
      use_ellipses: False
      sat_required_snowball: True
      min_sat_radius_extend: 2.5
      sat_expand: 2
      edge_size: 25
      mask_snowball_core_next_int: True
      snowball_time_masked_next_int: 4000
      find_showers: False
      max_shower_amplitude: 4.0
      extend_snr_threshold: 0.0
      extend_min_area: 0
      extend_inner_radius: 0
      extend_outer_radius: 0.0
      extend_ellipse_expand_ratio: 0.0
      time_masked_after_shower: 0
      min_diffs_single_pass: 10
      max_extended_radius: 200
      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 12:49:44,464 - stpipe.Detector1Pipeline - INFO - Prefetching reference files for dataset: 'jw02739001002_02105_00001_nrca4_uncal.fits' reftypes = ['dark', 'gain', 'linearity', 'mask', 'readnoise', 'refpix', 'reset', 'rscd', 'saturation', 'sirskernel', 'superbias']
2025-09-13 12:49:44,467 - CRDS - INFO -  Fetching  /home/runner/crds/references/jwst/nircam/jwst_nircam_dark_0334.fits    6.3 G bytes  (1 / 7 files) (0 / 6.6 G bytes)
2025-09-13 12:50:58,402 - CRDS - INFO -  Fetching  /home/runner/crds/references/jwst/nircam/jwst_nircam_gain_0096.fits   16.8 M bytes  (2 / 7 files) (6.3 G / 6.6 G bytes)
2025-09-13 12:50:58,557 - CRDS - INFO -  Fetching  /home/runner/crds/references/jwst/nircam/jwst_nircam_linearity_0055.fits  151.0 M bytes  (3 / 7 files) (6.3 G / 6.6 G bytes)
2025-09-13 12:51:00,410 - CRDS - INFO -  Fetching  /home/runner/crds/references/jwst/nircam/jwst_nircam_mask_0078.fits   16.8 M bytes  (4 / 7 files) (6.5 G / 6.6 G bytes)
2025-09-13 12:51:00,668 - CRDS - INFO -  Fetching  /home/runner/crds/references/jwst/nircam/jwst_nircam_readnoise_0248.fits   16.8 M bytes  (5 / 7 files) (6.5 G / 6.6 G bytes)
2025-09-13 12:51:00,969 - CRDS - INFO -  Fetching  /home/runner/crds/references/jwst/nircam/jwst_nircam_saturation_0099.fits   33.6 M bytes  (6 / 7 files) (6.5 G / 6.6 G bytes)
2025-09-13 12:51:01,644 - CRDS - INFO -  Fetching  /home/runner/crds/references/jwst/nircam/jwst_nircam_superbias_0212.fits   50.4 M bytes  (7 / 7 files) (6.5 G / 6.6 G bytes)
2025-09-13 12:51:02,325 - stpipe.Detector1Pipeline - INFO - Prefetch for DARK reference file is '/home/runner/crds/references/jwst/nircam/jwst_nircam_dark_0334.fits'.
2025-09-13 12:51:02,326 - stpipe.Detector1Pipeline - INFO - Prefetch for GAIN reference file is '/home/runner/crds/references/jwst/nircam/jwst_nircam_gain_0096.fits'.
2025-09-13 12:51:02,327 - stpipe.Detector1Pipeline - INFO - Prefetch for LINEARITY reference file is '/home/runner/crds/references/jwst/nircam/jwst_nircam_linearity_0055.fits'.
2025-09-13 12:51:02,327 - stpipe.Detector1Pipeline - INFO - Prefetch for MASK reference file is '/home/runner/crds/references/jwst/nircam/jwst_nircam_mask_0078.fits'.
2025-09-13 12:51:02,327 - stpipe.Detector1Pipeline - INFO - Prefetch for READNOISE reference file is '/home/runner/crds/references/jwst/nircam/jwst_nircam_readnoise_0248.fits'.
2025-09-13 12:51:02,328 - stpipe.Detector1Pipeline - INFO - Prefetch for REFPIX reference file is 'N/A'.
2025-09-13 12:51:02,328 - stpipe.Detector1Pipeline - INFO - Prefetch for RESET reference file is 'N/A'.
2025-09-13 12:51:02,329 - stpipe.Detector1Pipeline - INFO - Prefetch for RSCD reference file is 'N/A'.
2025-09-13 12:51:02,329 - stpipe.Detector1Pipeline - INFO - Prefetch for SATURATION reference file is '/home/runner/crds/references/jwst/nircam/jwst_nircam_saturation_0099.fits'.
2025-09-13 12:51:02,330 - stpipe.Detector1Pipeline - INFO - Prefetch for SIRSKERNEL reference file is '/home/runner/crds/references/jwst/nircam/jwst_nircam_sirskernel_0002.asdf'.
2025-09-13 12:51:02,331 - stpipe.Detector1Pipeline - INFO - Prefetch for SUPERBIAS reference file is '/home/runner/crds/references/jwst/nircam/jwst_nircam_superbias_0212.fits'.
2025-09-13 12:51:02,331 - jwst.pipeline.calwebb_detector1 - INFO - Starting calwebb_detector1 ...
2025-09-13 12:51:02,693 - stpipe.Detector1Pipeline.group_scale - INFO - Step group_scale running with args (<RampModel(1, 8, 2048, 2048) from jw02739001002_02105_00001_nrca4_uncal.fits>,).
2025-09-13 12:51:02,701 - stpipe.Detector1Pipeline.group_scale - INFO - NFRAMES and FRMDIVSR are equal; correction not needed
2025-09-13 12:51:02,701 - stpipe.Detector1Pipeline.group_scale - INFO - Step will be skipped
2025-09-13 12:51:02,703 - stpipe.Detector1Pipeline.group_scale - INFO - Step group_scale done
2025-09-13 12:51:02,886 - stpipe.Detector1Pipeline.dq_init - INFO - Step dq_init running with args (<RampModel(1, 8, 2048, 2048) from jw02739001002_02105_00001_nrca4_uncal.fits>,).
2025-09-13 12:51:02,895 - stpipe.Detector1Pipeline.dq_init - INFO - Using MASK reference file /home/runner/crds/references/jwst/nircam/jwst_nircam_mask_0078.fits
2025-09-13 12:51:03,096 - stpipe.Detector1Pipeline.dq_init - INFO - Step dq_init done
2025-09-13 12:51:03,291 - stpipe.Detector1Pipeline.saturation - INFO - Step saturation running with args (<RampModel(1, 8, 2048, 2048) from jw02739001002_02105_00001_nrca4_uncal.fits>,).
2025-09-13 12:51:03,301 - stpipe.Detector1Pipeline.saturation - INFO - Using SATURATION reference file /home/runner/crds/references/jwst/nircam/jwst_nircam_saturation_0099.fits
2025-09-13 12:51:03,302 - stpipe.Detector1Pipeline.saturation - INFO - Using SUPERBIAS reference file /home/runner/crds/references/jwst/nircam/jwst_nircam_superbias_0212.fits
2025-09-13 12:51:03,347 - stdatamodels.dynamicdq - WARNING - Keyword RESERVED_4 does not correspond to an existing DQ mnemonic, so will be ignored
2025-09-13 12:51:03,392 - stdatamodels.dynamicdq - WARNING - Keyword UNRELIABLE_RESET does not correspond to an existing DQ mnemonic, so will be ignored
2025-09-13 12:51:03,524 - jwst.saturation.saturation - INFO - Using read_pattern with nframes 1
2025-09-13 12:51:03,835 - stcal.saturation.saturation - INFO - Detected 5208 saturated pixels
2025-09-13 12:51:03,851 - stcal.saturation.saturation - INFO - Detected 0 A/D floor pixels
2025-09-13 12:51:03,858 - stpipe.Detector1Pipeline.saturation - INFO - Step saturation done
2025-09-13 12:51:04,046 - stpipe.Detector1Pipeline.ipc - INFO - Step ipc running with args (<RampModel(1, 8, 2048, 2048) from jw02739001002_02105_00001_nrca4_uncal.fits>,).
2025-09-13 12:51:04,046 - stpipe.Detector1Pipeline.ipc - INFO - Step skipped.
2025-09-13 12:51:04,238 - stpipe.Detector1Pipeline.superbias - INFO - Step superbias running with args (<RampModel(1, 8, 2048, 2048) from jw02739001002_02105_00001_nrca4_uncal.fits>,).
2025-09-13 12:51:04,248 - stpipe.Detector1Pipeline.superbias - INFO - Using SUPERBIAS reference file /home/runner/crds/references/jwst/nircam/jwst_nircam_superbias_0212.fits
2025-09-13 12:51:04,511 - stpipe.Detector1Pipeline.superbias - INFO - Step superbias done
2025-09-13 12:51:04,697 - stpipe.Detector1Pipeline.refpix - INFO - Step refpix running with args (<RampModel(1, 8, 2048, 2048) from jw02739001002_02105_00001_nrca4_uncal.fits>,).
2025-09-13 12:51:04,723 - stpipe.Detector1Pipeline.refpix - INFO - Using SIRS reference file: /home/runner/crds/references/jwst/nircam/jwst_nircam_sirskernel_0002.asdf
2025-09-13 12:51:04,741 - jwst.refpix.reference_pixels - INFO - NIR full frame data
2025-09-13 12:51:04,741 - jwst.refpix.reference_pixels - INFO - The following parameters are valid for this mode:
2025-09-13 12:51:04,741 - jwst.refpix.reference_pixels - INFO - sigreject = 4.0
2025-09-13 12:51:04,742 - jwst.refpix.reference_pixels - INFO - gaussmooth = 1.0
2025-09-13 12:51:04,743 - jwst.refpix.reference_pixels - INFO - halfwidth = 30
2025-09-13 12:51:05,057 - stpipe.Detector1Pipeline.refpix - INFO - Step refpix done
2025-09-13 12:51:05,248 - stpipe.Detector1Pipeline.linearity - INFO - Step linearity running with args (<RampModel(1, 8, 2048, 2048) from jw02739001002_02105_00001_nrca4_uncal.fits>,).
2025-09-13 12:51:05,257 - stpipe.Detector1Pipeline.linearity - INFO - Using Linearity reference file /home/runner/crds/references/jwst/nircam/jwst_nircam_linearity_0055.fits
2025-09-13 12:51:05,302 - stdatamodels.dynamicdq - WARNING - Keyword UAZ_DO_NOT_USE does not correspond to an existing DQ mnemonic, so will be ignored
2025-09-13 12:51:05,303 - stdatamodels.dynamicdq - WARNING - Keyword UAZ_NO_LIN_SAMP does not correspond to an existing DQ mnemonic, so will be ignored
2025-09-13 12:51:05,303 - stdatamodels.dynamicdq - WARNING - Keyword UAZ_BAD_LIN_FIT does not correspond to an existing DQ mnemonic, so will be ignored
2025-09-13 12:51:05,304 - stdatamodels.dynamicdq - WARNING - Keyword UAZ_NO_WELL_SAMP does not correspond to an existing DQ mnemonic, so will be ignored
2025-09-13 12:51:05,304 - stdatamodels.dynamicdq - WARNING - Keyword UAZ_MODEL_FIT_FAIL does not correspond to an existing DQ mnemonic, so will be ignored
2025-09-13 12:51:05,305 - stdatamodels.dynamicdq - WARNING - Keyword UAZ_WELL_NOT_DEFINED does not correspond to an existing DQ mnemonic, so will be ignored
2025-09-13 12:51:05,305 - stdatamodels.dynamicdq - WARNING - Keyword UAZ_MASTER_MASK does not correspond to an existing DQ mnemonic, so will be ignored
2025-09-13 12:51:05,800 - stpipe.Detector1Pipeline.linearity - INFO - Step linearity done
2025-09-13 12:51:05,984 - stpipe.Detector1Pipeline.persistence - INFO - Step persistence running with args (<RampModel(1, 8, 2048, 2048) from jw02739001002_02105_00001_nrca4_uncal.fits>,).
2025-09-13 12:51:05,985 - stpipe.Detector1Pipeline.persistence - INFO - Step skipped.
2025-09-13 12:51:06,166 - stpipe.Detector1Pipeline.dark_current - INFO - Step dark_current running with args (<RampModel(1, 8, 2048, 2048) from jw02739001002_02105_00001_nrca4_uncal.fits>,).
2025-09-13 12:51:06,176 - stpipe.Detector1Pipeline.dark_current - INFO - Using DARK reference file /home/runner/crds/references/jwst/nircam/jwst_nircam_dark_0334.fits
2025-09-13 12:51:08,663 - stdatamodels.dynamicdq - WARNING - Keyword RESERVED_4 does not correspond to an existing DQ mnemonic, so will be ignored
2025-09-13 12:51:08,701 - stdatamodels.dynamicdq - WARNING - Keyword UNRELIABLE_RESET does not correspond to an existing DQ mnemonic, so will be ignored
2025-09-13 12:51:08,711 - stcal.dark_current.dark_sub - INFO - Science data nints=1, ngroups=8, nframes=1, groupgap=1
2025-09-13 12:51:08,712 - stcal.dark_current.dark_sub - INFO - Dark data nints=1, ngroups=187, nframes=1, groupgap=0
2025-09-13 12:51:09,880 - stpipe.Detector1Pipeline.dark_current - INFO - Step dark_current done
2025-09-13 12:51:10,095 - stpipe.Detector1Pipeline.charge_migration - INFO - Step charge_migration running with args (<RampModel(1, 8, 2048, 2048) from jw02739001002_02105_00001_nrca4_uncal.fits>,).
2025-09-13 12:51:10,096 - stpipe.Detector1Pipeline.charge_migration - INFO - Step skipped.
2025-09-13 12:51:10,283 - stpipe.Detector1Pipeline.jump - INFO - Step jump running with args (<RampModel(1, 8, 2048, 2048) from jw02739001002_02105_00001_nrca4_uncal.fits>,).
2025-09-13 12:51:10,291 - stpipe.Detector1Pipeline.jump - INFO - CR rejection threshold = 4 sigma
2025-09-13 12:51:10,291 - stpipe.Detector1Pipeline.jump - INFO - Maximum cores to use = half
2025-09-13 12:51:10,312 - stpipe.Detector1Pipeline.jump - INFO - Using GAIN reference file: /home/runner/crds/references/jwst/nircam/jwst_nircam_gain_0096.fits
2025-09-13 12:51:10,314 - stpipe.Detector1Pipeline.jump - INFO - Using READNOISE reference file: /home/runner/crds/references/jwst/nircam/jwst_nircam_readnoise_0248.fits
2025-09-13 12:51:10,427 - stcal.jump.jump - INFO - Executing two-point difference method
2025-09-13 12:51:10,428 - stcal.jump.jump - INFO - Creating 2 processes for jump detection 
2025-09-13 12:51:13,754 - stcal.jump.jump - INFO - Flagging Snowballs
2025-09-13 12:51:13,925 - stcal.jump.jump - INFO - Total snowballs = 59
2025-09-13 12:51:13,926 - stcal.jump.jump - INFO - Total elapsed time = 3.49815 sec
2025-09-13 12:51:13,963 - stpipe.Detector1Pipeline.jump - INFO - The execution time in seconds: 3.672297
2025-09-13 12:51:13,966 - stpipe.Detector1Pipeline.jump - INFO - Step jump done
2025-09-13 12:51:14,144 - stpipe.Detector1Pipeline.clean_flicker_noise - INFO - Step clean_flicker_noise running with args (<RampModel(1, 8, 2048, 2048) from jw02739001002_02105_00001_nrca4_uncal.fits>,).
2025-09-13 12:51:14,144 - stpipe.Detector1Pipeline.clean_flicker_noise - INFO - Step skipped.
2025-09-13 12:51:14,313 - stpipe.Detector1Pipeline.ramp_fit - INFO - Step ramp_fit running with args (<RampModel(1, 8, 2048, 2048) from jw02739001002_02105_00001_nrca4_uncal.fits>,).
2025-09-13 12:51:14,349 - jwst.ramp_fitting.ramp_fit_step - INFO - Using READNOISE reference file: /home/runner/crds/references/jwst/nircam/jwst_nircam_readnoise_0248.fits
2025-09-13 12:51:14,349 - jwst.ramp_fitting.ramp_fit_step - INFO - Using GAIN reference file: /home/runner/crds/references/jwst/nircam/jwst_nircam_gain_0096.fits
2025-09-13 12:51:14,377 - jwst.ramp_fitting.ramp_fit_step - INFO - Using algorithm = OLS_C
2025-09-13 12:51:14,378 - jwst.ramp_fitting.ramp_fit_step - INFO - Using weighting = optimal
2025-09-13 12:51:14,515 - stcal.ramp_fitting.ols_fit - INFO - Number of multiprocessing slices: 1
2025-09-13 12:51:17,112 - stcal.ramp_fitting.ols_fit - INFO - Ramp Fitting C Time: 2.592961311340332
2025-09-13 12:51:17,154 - stpipe.Detector1Pipeline.ramp_fit - INFO - Step ramp_fit done
2025-09-13 12:51:17,330 - stpipe.Detector1Pipeline.gain_scale - INFO - Step gain_scale running with args (<ImageModel(2048, 2048) from jw02739001002_02105_00001_nrca4_uncal.fits>,).
2025-09-13 12:51:17,349 - stpipe.Detector1Pipeline.gain_scale - INFO - GAINFACT not found in gain reference file
2025-09-13 12:51:17,349 - stpipe.Detector1Pipeline.gain_scale - INFO - Step will be skipped
2025-09-13 12:51:17,352 - stpipe.Detector1Pipeline.gain_scale - INFO - Step gain_scale done
2025-09-13 12:51:17,523 - stpipe.Detector1Pipeline.gain_scale - INFO - Step gain_scale running with args (<CubeModel(1, 2048, 2048) from jw02739001002_02105_00001_nrca4_uncal.fits>,).
2025-09-13 12:51:17,544 - stpipe.Detector1Pipeline.gain_scale - INFO - GAINFACT not found in gain reference file
2025-09-13 12:51:17,544 - stpipe.Detector1Pipeline.gain_scale - INFO - Step will be skipped
2025-09-13 12:51:17,546 - stpipe.Detector1Pipeline.gain_scale - INFO - Step gain_scale done
2025-09-13 12:51:17,656 - stpipe.Detector1Pipeline - INFO - Saved model in ./nrc_im_demo_data/Obs001/stage1/jw02739001002_02105_00001_nrca4_rateints.fits
2025-09-13 12:51:17,657 - jwst.pipeline.calwebb_detector1 - INFO - ... ending calwebb_detector1
2025-09-13 12:51:17,659 - jwst.stpipe.core - INFO - Results used CRDS context: jwst_1413.pmap
2025-09-13 12:51:17,768 - stpipe.Detector1Pipeline - INFO - Saved model in ./nrc_im_demo_data/Obs001/stage1/jw02739001002_02105_00001_nrca4_rate.fits
2025-09-13 12:51:17,769 - stpipe.Detector1Pipeline - INFO - Step Detector1Pipeline done
2025-09-13 12:51:17,769 - jwst.stpipe.core - INFO - Results used jwst version: 1.19.1
2025-09-13 12:51:17,800 - CRDS - ERROR -  Error determining best reference for 'pars-darkcurrentstep'  =   No match found.
2025-09-13 12:51:17,804 - stpipe - INFO - PARS-JUMPSTEP parameters found: /home/runner/crds/references/jwst/nircam/jwst_nircam_pars-jumpstep_0003.asdf
2025-09-13 12:51:17,816 - stpipe - INFO - PARS-DETECTOR1PIPELINE parameters found: /home/runner/crds/references/jwst/nircam/jwst_nircam_pars-detector1pipeline_0005.asdf
2025-09-13 12:51:17,832 - stpipe.Detector1Pipeline - INFO - Detector1Pipeline instance created.
2025-09-13 12:51:17,832 - stpipe.Detector1Pipeline.group_scale - INFO - GroupScaleStep instance created.
2025-09-13 12:51:17,834 - stpipe.Detector1Pipeline.dq_init - INFO - DQInitStep instance created.
2025-09-13 12:51:17,835 - stpipe.Detector1Pipeline.emicorr - INFO - EmiCorrStep instance created.
2025-09-13 12:51:17,836 - stpipe.Detector1Pipeline.saturation - INFO - SaturationStep instance created.
2025-09-13 12:51:17,837 - stpipe.Detector1Pipeline.ipc - INFO - IPCStep instance created.
2025-09-13 12:51:17,837 - stpipe.Detector1Pipeline.superbias - INFO - SuperBiasStep instance created.
2025-09-13 12:51:17,838 - stpipe.Detector1Pipeline.refpix - INFO - RefPixStep instance created.
2025-09-13 12:51:17,839 - stpipe.Detector1Pipeline.rscd - INFO - RscdStep instance created.
2025-09-13 12:51:17,840 - stpipe.Detector1Pipeline.firstframe - INFO - FirstFrameStep instance created.
2025-09-13 12:51:17,841 - stpipe.Detector1Pipeline.lastframe - INFO - LastFrameStep instance created.
2025-09-13 12:51:17,841 - stpipe.Detector1Pipeline.linearity - INFO - LinearityStep instance created.
2025-09-13 12:51:17,842 - stpipe.Detector1Pipeline.dark_current - INFO - DarkCurrentStep instance created.
2025-09-13 12:51:17,844 - stpipe.Detector1Pipeline.reset - INFO - ResetStep instance created.
2025-09-13 12:51:17,845 - stpipe.Detector1Pipeline.persistence - INFO - PersistenceStep instance created.
2025-09-13 12:51:17,846 - stpipe.Detector1Pipeline.charge_migration - INFO - ChargeMigrationStep instance created.
2025-09-13 12:51:17,847 - stpipe.Detector1Pipeline.jump - INFO - JumpStep instance created.
2025-09-13 12:51:17,849 - stpipe.Detector1Pipeline.clean_flicker_noise - INFO - CleanFlickerNoiseStep instance created.
2025-09-13 12:51:17,850 - stpipe.Detector1Pipeline.ramp_fit - INFO - RampFitStep instance created.
2025-09-13 12:51:17,851 - stpipe.Detector1Pipeline.gain_scale - INFO - GainScaleStep instance created.
2025-09-13 12:51:18,035 - stpipe.Detector1Pipeline - INFO - Step Detector1Pipeline running with args ('./nrc_im_demo_data/Obs001/uncal/jw02739001002_02105_00001_nrcalong_uncal.fits',).
2025-09-13 12:51:18,055 - stpipe.Detector1Pipeline - INFO - Step Detector1Pipeline parameters are:
  pre_hooks: []
  post_hooks: []
  output_file: None
  output_dir: ./nrc_im_demo_data/Obs001/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: sirs
      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: True
      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: True
      suffix: None
      search_output_file: True
      input_dir: ''
      signal_threshold: 25000.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: half
      flag_4_neighbors: True
      max_jump_to_flag_neighbors: 1000
      min_jump_to_flag_neighbors: 30
      after_jump_flag_dn1: 0
      after_jump_flag_time1: 0
      after_jump_flag_dn2: 0
      after_jump_flag_time2: 0
      expand_large_events: True
      min_sat_area: 1
      min_jump_area: 5
      expand_factor: 2
      use_ellipses: False
      sat_required_snowball: True
      min_sat_radius_extend: 2.5
      sat_expand: 2
      edge_size: 25
      mask_snowball_core_next_int: True
      snowball_time_masked_next_int: 4000
      find_showers: False
      max_shower_amplitude: 4.0
      extend_snr_threshold: 0.0
      extend_min_area: 0
      extend_inner_radius: 0
      extend_outer_radius: 0.0
      extend_ellipse_expand_ratio: 0.0
      time_masked_after_shower: 0
      min_diffs_single_pass: 10
      max_extended_radius: 200
      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 12:51:18,075 - stpipe.Detector1Pipeline - INFO - Prefetching reference files for dataset: 'jw02739001002_02105_00001_nrcalong_uncal.fits' reftypes = ['dark', 'gain', 'linearity', 'mask', 'readnoise', 'refpix', 'reset', 'rscd', 'saturation', 'sirskernel', 'superbias']
2025-09-13 12:51:18,078 - CRDS - INFO -  Fetching  /home/runner/crds/references/jwst/nircam/jwst_nircam_dark_0424.fits    4.4 G bytes  (1 / 7 files) (0 / 4.7 G bytes)
2025-09-13 12:52:25,953 - CRDS - INFO -  Fetching  /home/runner/crds/references/jwst/nircam/jwst_nircam_gain_0097.fits   16.8 M bytes  (2 / 7 files) (4.4 G / 4.7 G bytes)
2025-09-13 12:52:26,147 - CRDS - INFO -  Fetching  /home/runner/crds/references/jwst/nircam/jwst_nircam_linearity_0052.fits  151.0 M bytes  (3 / 7 files) (4.4 G / 4.7 G bytes)
2025-09-13 12:52:26,962 - CRDS - INFO -  Fetching  /home/runner/crds/references/jwst/nircam/jwst_nircam_mask_0076.fits   16.8 M bytes  (4 / 7 files) (4.5 G / 4.7 G bytes)
2025-09-13 12:52:27,170 - CRDS - INFO -  Fetching  /home/runner/crds/references/jwst/nircam/jwst_nircam_readnoise_0266.fits   16.8 M bytes  (5 / 7 files) (4.6 G / 4.7 G bytes)
2025-09-13 12:52:27,478 - CRDS - INFO -  Fetching  /home/runner/crds/references/jwst/nircam/jwst_nircam_saturation_0097.fits   33.6 M bytes  (6 / 7 files) (4.6 G / 4.7 G bytes)
2025-09-13 12:52:27,733 - CRDS - INFO -  Fetching  /home/runner/crds/references/jwst/nircam/jwst_nircam_superbias_0220.fits   50.4 M bytes  (7 / 7 files) (4.6 G / 4.7 G bytes)
2025-09-13 12:52:28,409 - stpipe.Detector1Pipeline - INFO - Prefetch for DARK reference file is '/home/runner/crds/references/jwst/nircam/jwst_nircam_dark_0424.fits'.
2025-09-13 12:52:28,409 - stpipe.Detector1Pipeline - INFO - Prefetch for GAIN reference file is '/home/runner/crds/references/jwst/nircam/jwst_nircam_gain_0097.fits'.
2025-09-13 12:52:28,410 - stpipe.Detector1Pipeline - INFO - Prefetch for LINEARITY reference file is '/home/runner/crds/references/jwst/nircam/jwst_nircam_linearity_0052.fits'.
2025-09-13 12:52:28,410 - stpipe.Detector1Pipeline - INFO - Prefetch for MASK reference file is '/home/runner/crds/references/jwst/nircam/jwst_nircam_mask_0076.fits'.
2025-09-13 12:52:28,411 - stpipe.Detector1Pipeline - INFO - Prefetch for READNOISE reference file is '/home/runner/crds/references/jwst/nircam/jwst_nircam_readnoise_0266.fits'.
2025-09-13 12:52:28,412 - stpipe.Detector1Pipeline - INFO - Prefetch for REFPIX reference file is 'N/A'.
2025-09-13 12:52:28,412 - stpipe.Detector1Pipeline - INFO - Prefetch for RESET reference file is 'N/A'.
2025-09-13 12:52:28,412 - stpipe.Detector1Pipeline - INFO - Prefetch for RSCD reference file is 'N/A'.
2025-09-13 12:52:28,413 - stpipe.Detector1Pipeline - INFO - Prefetch for SATURATION reference file is '/home/runner/crds/references/jwst/nircam/jwst_nircam_saturation_0097.fits'.
2025-09-13 12:52:28,414 - stpipe.Detector1Pipeline - INFO - Prefetch for SIRSKERNEL reference file is '/home/runner/crds/references/jwst/nircam/jwst_nircam_sirskernel_0002.asdf'.
2025-09-13 12:52:28,414 - stpipe.Detector1Pipeline - INFO - Prefetch for SUPERBIAS reference file is '/home/runner/crds/references/jwst/nircam/jwst_nircam_superbias_0220.fits'.
2025-09-13 12:52:28,415 - jwst.pipeline.calwebb_detector1 - INFO - Starting calwebb_detector1 ...
2025-09-13 12:52:28,755 - stpipe.Detector1Pipeline.group_scale - INFO - Step group_scale running with args (<RampModel(1, 8, 2048, 2048) from jw02739001002_02105_00001_nrcalong_uncal.fits>,).
2025-09-13 12:52:28,763 - stpipe.Detector1Pipeline.group_scale - INFO - NFRAMES and FRMDIVSR are equal; correction not needed
2025-09-13 12:52:28,763 - stpipe.Detector1Pipeline.group_scale - INFO - Step will be skipped
2025-09-13 12:52:28,765 - stpipe.Detector1Pipeline.group_scale - INFO - Step group_scale done
2025-09-13 12:52:28,941 - stpipe.Detector1Pipeline.dq_init - INFO - Step dq_init running with args (<RampModel(1, 8, 2048, 2048) from jw02739001002_02105_00001_nrcalong_uncal.fits>,).
2025-09-13 12:52:28,950 - stpipe.Detector1Pipeline.dq_init - INFO - Using MASK reference file /home/runner/crds/references/jwst/nircam/jwst_nircam_mask_0076.fits
2025-09-13 12:52:29,152 - stpipe.Detector1Pipeline.dq_init - INFO - Step dq_init done
2025-09-13 12:52:29,333 - stpipe.Detector1Pipeline.saturation - INFO - Step saturation running with args (<RampModel(1, 8, 2048, 2048) from jw02739001002_02105_00001_nrcalong_uncal.fits>,).
2025-09-13 12:52:29,344 - stpipe.Detector1Pipeline.saturation - INFO - Using SATURATION reference file /home/runner/crds/references/jwst/nircam/jwst_nircam_saturation_0097.fits
2025-09-13 12:52:29,344 - stpipe.Detector1Pipeline.saturation - INFO - Using SUPERBIAS reference file /home/runner/crds/references/jwst/nircam/jwst_nircam_superbias_0220.fits
2025-09-13 12:52:29,388 - stdatamodels.dynamicdq - WARNING - Keyword RESERVED_4 does not correspond to an existing DQ mnemonic, so will be ignored
2025-09-13 12:52:29,433 - stdatamodels.dynamicdq - WARNING - Keyword UNRELIABLE_RESET does not correspond to an existing DQ mnemonic, so will be ignored
2025-09-13 12:52:29,558 - jwst.saturation.saturation - INFO - Using read_pattern with nframes 1
2025-09-13 12:52:29,856 - stcal.saturation.saturation - INFO - Detected 27972 saturated pixels
2025-09-13 12:52:29,872 - stcal.saturation.saturation - INFO - Detected 0 A/D floor pixels
2025-09-13 12:52:29,878 - stpipe.Detector1Pipeline.saturation - INFO - Step saturation done
2025-09-13 12:52:30,058 - stpipe.Detector1Pipeline.ipc - INFO - Step ipc running with args (<RampModel(1, 8, 2048, 2048) from jw02739001002_02105_00001_nrcalong_uncal.fits>,).
2025-09-13 12:52:30,059 - stpipe.Detector1Pipeline.ipc - INFO - Step skipped.
2025-09-13 12:52:30,234 - stpipe.Detector1Pipeline.superbias - INFO - Step superbias running with args (<RampModel(1, 8, 2048, 2048) from jw02739001002_02105_00001_nrcalong_uncal.fits>,).
2025-09-13 12:52:30,244 - stpipe.Detector1Pipeline.superbias - INFO - Using SUPERBIAS reference file /home/runner/crds/references/jwst/nircam/jwst_nircam_superbias_0220.fits
2025-09-13 12:52:30,478 - stpipe.Detector1Pipeline.superbias - INFO - Step superbias done
2025-09-13 12:52:30,653 - stpipe.Detector1Pipeline.refpix - INFO - Step refpix running with args (<RampModel(1, 8, 2048, 2048) from jw02739001002_02105_00001_nrcalong_uncal.fits>,).
2025-09-13 12:52:30,685 - stpipe.Detector1Pipeline.refpix - INFO - Using SIRS reference file: /home/runner/crds/references/jwst/nircam/jwst_nircam_sirskernel_0002.asdf
2025-09-13 12:52:30,704 - jwst.refpix.reference_pixels - INFO - NIR full frame data
2025-09-13 12:52:30,704 - jwst.refpix.reference_pixels - INFO - The following parameters are valid for this mode:
2025-09-13 12:52:30,705 - jwst.refpix.reference_pixels - INFO - sigreject = 4.0
2025-09-13 12:52:30,705 - jwst.refpix.reference_pixels - INFO - gaussmooth = 1.0
2025-09-13 12:52:30,706 - jwst.refpix.reference_pixels - INFO - halfwidth = 30
2025-09-13 12:52:30,967 - stpipe.Detector1Pipeline.refpix - INFO - Step refpix done
2025-09-13 12:52:31,144 - stpipe.Detector1Pipeline.linearity - INFO - Step linearity running with args (<RampModel(1, 8, 2048, 2048) from jw02739001002_02105_00001_nrcalong_uncal.fits>,).
2025-09-13 12:52:31,153 - stpipe.Detector1Pipeline.linearity - INFO - Using Linearity reference file /home/runner/crds/references/jwst/nircam/jwst_nircam_linearity_0052.fits
2025-09-13 12:52:31,197 - stdatamodels.dynamicdq - WARNING - Keyword UAZ_DO_NOT_USE does not correspond to an existing DQ mnemonic, so will be ignored
2025-09-13 12:52:31,197 - stdatamodels.dynamicdq - WARNING - Keyword UAZ_NO_LIN_SAMP does not correspond to an existing DQ mnemonic, so will be ignored
2025-09-13 12:52:31,198 - stdatamodels.dynamicdq - WARNING - Keyword UAZ_BAD_LIN_FIT does not correspond to an existing DQ mnemonic, so will be ignored
2025-09-13 12:52:31,199 - stdatamodels.dynamicdq - WARNING - Keyword UAZ_NO_WELL_SAMP does not correspond to an existing DQ mnemonic, so will be ignored
2025-09-13 12:52:31,199 - stdatamodels.dynamicdq - WARNING - Keyword UAZ_MODEL_FIT_FAIL does not correspond to an existing DQ mnemonic, so will be ignored
2025-09-13 12:52:31,200 - stdatamodels.dynamicdq - WARNING - Keyword UAZ_WELL_NOT_DEFINED does not correspond to an existing DQ mnemonic, so will be ignored
2025-09-13 12:52:31,200 - stdatamodels.dynamicdq - WARNING - Keyword UAZ_MASTER_MASK does not correspond to an existing DQ mnemonic, so will be ignored
2025-09-13 12:52:31,730 - stpipe.Detector1Pipeline.linearity - INFO - Step linearity done
2025-09-13 12:52:31,907 - stpipe.Detector1Pipeline.persistence - INFO - Step persistence running with args (<RampModel(1, 8, 2048, 2048) from jw02739001002_02105_00001_nrcalong_uncal.fits>,).
2025-09-13 12:52:31,908 - stpipe.Detector1Pipeline.persistence - INFO - Step skipped.
2025-09-13 12:52:32,084 - stpipe.Detector1Pipeline.dark_current - INFO - Step dark_current running with args (<RampModel(1, 8, 2048, 2048) from jw02739001002_02105_00001_nrcalong_uncal.fits>,).
2025-09-13 12:52:32,094 - stpipe.Detector1Pipeline.dark_current - INFO - Using DARK reference file /home/runner/crds/references/jwst/nircam/jwst_nircam_dark_0424.fits
2025-09-13 12:52:34,084 - stcal.dark_current.dark_sub - INFO - Science data nints=1, ngroups=8, nframes=1, groupgap=1
2025-09-13 12:52:34,085 - stcal.dark_current.dark_sub - INFO - Dark data nints=1, ngroups=130, nframes=1, groupgap=0
2025-09-13 12:52:34,745 - stpipe.Detector1Pipeline.dark_current - INFO - Step dark_current done
2025-09-13 12:52:34,922 - stpipe.Detector1Pipeline.charge_migration - INFO - Step charge_migration running with args (<RampModel(1, 8, 2048, 2048) from jw02739001002_02105_00001_nrcalong_uncal.fits>,).
2025-09-13 12:52:34,923 - stpipe.Detector1Pipeline.charge_migration - INFO - Step skipped.
2025-09-13 12:52:35,095 - stpipe.Detector1Pipeline.jump - INFO - Step jump running with args (<RampModel(1, 8, 2048, 2048) from jw02739001002_02105_00001_nrcalong_uncal.fits>,).
2025-09-13 12:52:35,102 - stpipe.Detector1Pipeline.jump - INFO - CR rejection threshold = 4 sigma
2025-09-13 12:52:35,102 - stpipe.Detector1Pipeline.jump - INFO - Maximum cores to use = half
2025-09-13 12:52:35,129 - stpipe.Detector1Pipeline.jump - INFO - Using GAIN reference file: /home/runner/crds/references/jwst/nircam/jwst_nircam_gain_0097.fits
2025-09-13 12:52:35,131 - stpipe.Detector1Pipeline.jump - INFO - Using READNOISE reference file: /home/runner/crds/references/jwst/nircam/jwst_nircam_readnoise_0266.fits
2025-09-13 12:52:35,242 - stcal.jump.jump - INFO - Executing two-point difference method
2025-09-13 12:52:35,243 - stcal.jump.jump - INFO - Creating 2 processes for jump detection 
2025-09-13 12:52:38,817 - stcal.jump.jump - INFO - Flagging Snowballs
2025-09-13 12:52:39,430 - stcal.jump.jump - INFO - Total snowballs = 259
2025-09-13 12:52:39,431 - stcal.jump.jump - INFO - Total elapsed time = 4.18814 sec
2025-09-13 12:52:39,469 - stpipe.Detector1Pipeline.jump - INFO - The execution time in seconds: 4.367237
2025-09-13 12:52:39,472 - stpipe.Detector1Pipeline.jump - INFO - Step jump done
2025-09-13 12:52:39,653 - stpipe.Detector1Pipeline.clean_flicker_noise - INFO - Step clean_flicker_noise running with args (<RampModel(1, 8, 2048, 2048) from jw02739001002_02105_00001_nrcalong_uncal.fits>,).
2025-09-13 12:52:39,654 - stpipe.Detector1Pipeline.clean_flicker_noise - INFO - Step skipped.
2025-09-13 12:52:39,829 - stpipe.Detector1Pipeline.ramp_fit - INFO - Step ramp_fit running with args (<RampModel(1, 8, 2048, 2048) from jw02739001002_02105_00001_nrcalong_uncal.fits>,).
2025-09-13 12:52:39,888 - jwst.ramp_fitting.ramp_fit_step - INFO - Using READNOISE reference file: /home/runner/crds/references/jwst/nircam/jwst_nircam_readnoise_0266.fits
2025-09-13 12:52:39,889 - jwst.ramp_fitting.ramp_fit_step - INFO - Using GAIN reference file: /home/runner/crds/references/jwst/nircam/jwst_nircam_gain_0097.fits
2025-09-13 12:52:39,916 - jwst.ramp_fitting.ramp_fit_step - INFO - Using algorithm = OLS_C
2025-09-13 12:52:39,916 - jwst.ramp_fitting.ramp_fit_step - INFO - Using weighting = optimal
2025-09-13 12:52:40,111 - stcal.ramp_fitting.ols_fit - INFO - Number of multiprocessing slices: 1
2025-09-13 12:52:42,684 - stcal.ramp_fitting.ols_fit - INFO - Ramp Fitting C Time: 2.5688016414642334
2025-09-13 12:52:42,728 - stpipe.Detector1Pipeline.ramp_fit - INFO - Step ramp_fit done
2025-09-13 12:52:42,910 - stpipe.Detector1Pipeline.gain_scale - INFO - Step gain_scale running with args (<ImageModel(2048, 2048) from jw02739001002_02105_00001_nrcalong_uncal.fits>,).
2025-09-13 12:52:42,930 - stpipe.Detector1Pipeline.gain_scale - INFO - GAINFACT not found in gain reference file
2025-09-13 12:52:42,930 - stpipe.Detector1Pipeline.gain_scale - INFO - Step will be skipped
2025-09-13 12:52:42,932 - stpipe.Detector1Pipeline.gain_scale - INFO - Step gain_scale done
2025-09-13 12:52:43,114 - stpipe.Detector1Pipeline.gain_scale - INFO - Step gain_scale running with args (<CubeModel(1, 2048, 2048) from jw02739001002_02105_00001_nrcalong_uncal.fits>,).
2025-09-13 12:52:43,134 - stpipe.Detector1Pipeline.gain_scale - INFO - GAINFACT not found in gain reference file
2025-09-13 12:52:43,134 - stpipe.Detector1Pipeline.gain_scale - INFO - Step will be skipped
2025-09-13 12:52:43,136 - stpipe.Detector1Pipeline.gain_scale - INFO - Step gain_scale done
2025-09-13 12:52:43,246 - stpipe.Detector1Pipeline - INFO - Saved model in ./nrc_im_demo_data/Obs001/stage1/jw02739001002_02105_00001_nrcalong_rateints.fits
2025-09-13 12:52:43,247 - jwst.pipeline.calwebb_detector1 - INFO - ... ending calwebb_detector1
2025-09-13 12:52:43,249 - jwst.stpipe.core - INFO - Results used CRDS context: jwst_1413.pmap
2025-09-13 12:52:43,359 - stpipe.Detector1Pipeline - INFO - Saved model in ./nrc_im_demo_data/Obs001/stage1/jw02739001002_02105_00001_nrcalong_rate.fits
2025-09-13 12:52:43,359 - stpipe.Detector1Pipeline - INFO - Step Detector1Pipeline done
2025-09-13 12:52:43,360 - jwst.stpipe.core - INFO - Results used jwst version: 1.19.1
2025-09-13 12:52:43,392 - CRDS - ERROR -  Error determining best reference for 'pars-darkcurrentstep'  =   No match found.
2025-09-13 12:52:43,396 - stpipe - INFO - PARS-JUMPSTEP parameters found: /home/runner/crds/references/jwst/nircam/jwst_nircam_pars-jumpstep_0003.asdf
2025-09-13 12:52:43,408 - stpipe - INFO - PARS-DETECTOR1PIPELINE parameters found: /home/runner/crds/references/jwst/nircam/jwst_nircam_pars-detector1pipeline_0005.asdf
2025-09-13 12:52:43,423 - stpipe.Detector1Pipeline - INFO - Detector1Pipeline instance created.
2025-09-13 12:52:43,424 - stpipe.Detector1Pipeline.group_scale - INFO - GroupScaleStep instance created.
2025-09-13 12:52:43,425 - stpipe.Detector1Pipeline.dq_init - INFO - DQInitStep instance created.
2025-09-13 12:52:43,426 - stpipe.Detector1Pipeline.emicorr - INFO - EmiCorrStep instance created.
2025-09-13 12:52:43,427 - stpipe.Detector1Pipeline.saturation - INFO - SaturationStep instance created.
2025-09-13 12:52:43,428 - stpipe.Detector1Pipeline.ipc - INFO - IPCStep instance created.
2025-09-13 12:52:43,429 - stpipe.Detector1Pipeline.superbias - INFO - SuperBiasStep instance created.
2025-09-13 12:52:43,431 - stpipe.Detector1Pipeline.refpix - INFO - RefPixStep instance created.
2025-09-13 12:52:43,431 - stpipe.Detector1Pipeline.rscd - INFO - RscdStep instance created.
2025-09-13 12:52:43,432 - stpipe.Detector1Pipeline.firstframe - INFO - FirstFrameStep instance created.
2025-09-13 12:52:43,433 - stpipe.Detector1Pipeline.lastframe - INFO - LastFrameStep instance created.
2025-09-13 12:52:43,434 - stpipe.Detector1Pipeline.linearity - INFO - LinearityStep instance created.
2025-09-13 12:52:43,435 - stpipe.Detector1Pipeline.dark_current - INFO - DarkCurrentStep instance created.
2025-09-13 12:52:43,436 - stpipe.Detector1Pipeline.reset - INFO - ResetStep instance created.
2025-09-13 12:52:43,437 - stpipe.Detector1Pipeline.persistence - INFO - PersistenceStep instance created.
2025-09-13 12:52:43,438 - stpipe.Detector1Pipeline.charge_migration - INFO - ChargeMigrationStep instance created.
2025-09-13 12:52:43,439 - stpipe.Detector1Pipeline.jump - INFO - JumpStep instance created.
2025-09-13 12:52:43,440 - stpipe.Detector1Pipeline.clean_flicker_noise - INFO - CleanFlickerNoiseStep instance created.
2025-09-13 12:52:43,441 - stpipe.Detector1Pipeline.ramp_fit - INFO - RampFitStep instance created.
2025-09-13 12:52:43,442 - stpipe.Detector1Pipeline.gain_scale - INFO - GainScaleStep instance created.
2025-09-13 12:52:43,617 - stpipe.Detector1Pipeline - INFO - Step Detector1Pipeline running with args ('./nrc_im_demo_data/Obs001/uncal/jw02739001002_02105_00002_nrca2_uncal.fits',).
2025-09-13 12:52:43,639 - stpipe.Detector1Pipeline - INFO - Step Detector1Pipeline parameters are:
  pre_hooks: []
  post_hooks: []
  output_file: None
  output_dir: ./nrc_im_demo_data/Obs001/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: sirs
      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: True
      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: True
      suffix: None
      search_output_file: True
      input_dir: ''
      signal_threshold: 25000.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: half
      flag_4_neighbors: True
      max_jump_to_flag_neighbors: 1000
      min_jump_to_flag_neighbors: 30
      after_jump_flag_dn1: 0
      after_jump_flag_time1: 0
      after_jump_flag_dn2: 0
      after_jump_flag_time2: 0
      expand_large_events: True
      min_sat_area: 1
      min_jump_area: 5
      expand_factor: 2
      use_ellipses: False
      sat_required_snowball: True
      min_sat_radius_extend: 2.5
      sat_expand: 2
      edge_size: 25
      mask_snowball_core_next_int: True
      snowball_time_masked_next_int: 4000
      find_showers: False
      max_shower_amplitude: 4.0
      extend_snr_threshold: 0.0
      extend_min_area: 0
      extend_inner_radius: 0
      extend_outer_radius: 0.0
      extend_ellipse_expand_ratio: 0.0
      time_masked_after_shower: 0
      min_diffs_single_pass: 10
      max_extended_radius: 200
      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 12:52:43,658 - stpipe.Detector1Pipeline - INFO - Prefetching reference files for dataset: 'jw02739001002_02105_00002_nrca2_uncal.fits' reftypes = ['dark', 'gain', 'linearity', 'mask', 'readnoise', 'refpix', 'reset', 'rscd', 'saturation', 'sirskernel', 'superbias']
2025-09-13 12:52:43,662 - stpipe.Detector1Pipeline - INFO - Prefetch for DARK reference file is '/home/runner/crds/references/jwst/nircam/jwst_nircam_dark_0342.fits'.
2025-09-13 12:52:43,662 - stpipe.Detector1Pipeline - INFO - Prefetch for GAIN reference file is '/home/runner/crds/references/jwst/nircam/jwst_nircam_gain_0093.fits'.
2025-09-13 12:52:43,663 - stpipe.Detector1Pipeline - INFO - Prefetch for LINEARITY reference file is '/home/runner/crds/references/jwst/nircam/jwst_nircam_linearity_0051.fits'.
2025-09-13 12:52:43,663 - stpipe.Detector1Pipeline - INFO - Prefetch for MASK reference file is '/home/runner/crds/references/jwst/nircam/jwst_nircam_mask_0072.fits'.
2025-09-13 12:52:43,664 - stpipe.Detector1Pipeline - INFO - Prefetch for READNOISE reference file is '/home/runner/crds/references/jwst/nircam/jwst_nircam_readnoise_0224.fits'.
2025-09-13 12:52:43,665 - stpipe.Detector1Pipeline - INFO - Prefetch for REFPIX reference file is 'N/A'.
2025-09-13 12:52:43,665 - stpipe.Detector1Pipeline - INFO - Prefetch for RESET reference file is 'N/A'.
2025-09-13 12:52:43,666 - stpipe.Detector1Pipeline - INFO - Prefetch for RSCD reference file is 'N/A'.
2025-09-13 12:52:43,666 - stpipe.Detector1Pipeline - INFO - Prefetch for SATURATION reference file is '/home/runner/crds/references/jwst/nircam/jwst_nircam_saturation_0104.fits'.
2025-09-13 12:52:43,667 - stpipe.Detector1Pipeline - INFO - Prefetch for SIRSKERNEL reference file is '/home/runner/crds/references/jwst/nircam/jwst_nircam_sirskernel_0002.asdf'.
2025-09-13 12:52:43,667 - stpipe.Detector1Pipeline - INFO - Prefetch for SUPERBIAS reference file is '/home/runner/crds/references/jwst/nircam/jwst_nircam_superbias_0186.fits'.
2025-09-13 12:52:43,668 - jwst.pipeline.calwebb_detector1 - INFO - Starting calwebb_detector1 ...
2025-09-13 12:52:44,005 - stpipe.Detector1Pipeline.group_scale - INFO - Step group_scale running with args (<RampModel(1, 8, 2048, 2048) from jw02739001002_02105_00002_nrca2_uncal.fits>,).
2025-09-13 12:52:44,013 - stpipe.Detector1Pipeline.group_scale - INFO - NFRAMES and FRMDIVSR are equal; correction not needed
2025-09-13 12:52:44,014 - stpipe.Detector1Pipeline.group_scale - INFO - Step will be skipped
2025-09-13 12:52:44,015 - stpipe.Detector1Pipeline.group_scale - INFO - Step group_scale done
2025-09-13 12:52:44,194 - stpipe.Detector1Pipeline.dq_init - INFO - Step dq_init running with args (<RampModel(1, 8, 2048, 2048) from jw02739001002_02105_00002_nrca2_uncal.fits>,).
2025-09-13 12:52:44,203 - stpipe.Detector1Pipeline.dq_init - INFO - Using MASK reference file /home/runner/crds/references/jwst/nircam/jwst_nircam_mask_0072.fits
2025-09-13 12:52:44,401 - stpipe.Detector1Pipeline.dq_init - INFO - Step dq_init done
2025-09-13 12:52:44,576 - stpipe.Detector1Pipeline.saturation - INFO - Step saturation running with args (<RampModel(1, 8, 2048, 2048) from jw02739001002_02105_00002_nrca2_uncal.fits>,).
2025-09-13 12:52:44,586 - stpipe.Detector1Pipeline.saturation - INFO - Using SATURATION reference file /home/runner/crds/references/jwst/nircam/jwst_nircam_saturation_0104.fits
2025-09-13 12:52:44,587 - stpipe.Detector1Pipeline.saturation - INFO - Using SUPERBIAS reference file /home/runner/crds/references/jwst/nircam/jwst_nircam_superbias_0186.fits
2025-09-13 12:52:44,644 - stdatamodels.dynamicdq - WARNING - Keyword RESERVED_4 does not correspond to an existing DQ mnemonic, so will be ignored
2025-09-13 12:52:44,689 - stdatamodels.dynamicdq - WARNING - Keyword UNRELIABLE_RESET does not correspond to an existing DQ mnemonic, so will be ignored
2025-09-13 12:52:44,860 - jwst.saturation.saturation - INFO - Using read_pattern with nframes 1
2025-09-13 12:52:45,152 - stcal.saturation.saturation - INFO - Detected 9023 saturated pixels
2025-09-13 12:52:45,164 - stcal.saturation.saturation - INFO - Detected 0 A/D floor pixels
2025-09-13 12:52:45,170 - stpipe.Detector1Pipeline.saturation - INFO - Step saturation done
2025-09-13 12:52:45,343 - stpipe.Detector1Pipeline.ipc - INFO - Step ipc running with args (<RampModel(1, 8, 2048, 2048) from jw02739001002_02105_00002_nrca2_uncal.fits>,).
2025-09-13 12:52:45,344 - stpipe.Detector1Pipeline.ipc - INFO - Step skipped.
2025-09-13 12:52:45,509 - stpipe.Detector1Pipeline.superbias - INFO - Step superbias running with args (<RampModel(1, 8, 2048, 2048) from jw02739001002_02105_00002_nrca2_uncal.fits>,).
2025-09-13 12:52:45,519 - stpipe.Detector1Pipeline.superbias - INFO - Using SUPERBIAS reference file /home/runner/crds/references/jwst/nircam/jwst_nircam_superbias_0186.fits
2025-09-13 12:52:45,749 - stpipe.Detector1Pipeline.superbias - INFO - Step superbias done
2025-09-13 12:52:45,933 - stpipe.Detector1Pipeline.refpix - INFO - Step refpix running with args (<RampModel(1, 8, 2048, 2048) from jw02739001002_02105_00002_nrca2_uncal.fits>,).
2025-09-13 12:52:45,958 - stpipe.Detector1Pipeline.refpix - INFO - Using SIRS reference file: /home/runner/crds/references/jwst/nircam/jwst_nircam_sirskernel_0002.asdf
2025-09-13 12:52:45,976 - jwst.refpix.reference_pixels - INFO - NIR full frame data
2025-09-13 12:52:45,977 - jwst.refpix.reference_pixels - INFO - The following parameters are valid for this mode:
2025-09-13 12:52:45,977 - jwst.refpix.reference_pixels - INFO - sigreject = 4.0
2025-09-13 12:52:45,978 - jwst.refpix.reference_pixels - INFO - gaussmooth = 1.0
2025-09-13 12:52:45,979 - jwst.refpix.reference_pixels - INFO - halfwidth = 30
2025-09-13 12:52:46,288 - stpipe.Detector1Pipeline.refpix - INFO - Step refpix done
2025-09-13 12:52:46,467 - stpipe.Detector1Pipeline.linearity - INFO - Step linearity running with args (<RampModel(1, 8, 2048, 2048) from jw02739001002_02105_00002_nrca2_uncal.fits>,).
2025-09-13 12:52:46,476 - stpipe.Detector1Pipeline.linearity - INFO - Using Linearity reference file /home/runner/crds/references/jwst/nircam/jwst_nircam_linearity_0051.fits
2025-09-13 12:52:46,569 - stdatamodels.dynamicdq - WARNING - Keyword UAZ_DO_NOT_USE does not correspond to an existing DQ mnemonic, so will be ignored
2025-09-13 12:52:46,570 - stdatamodels.dynamicdq - WARNING - Keyword UAZ_NO_LIN_SAMP does not correspond to an existing DQ mnemonic, so will be ignored
2025-09-13 12:52:46,570 - stdatamodels.dynamicdq - WARNING - Keyword UAZ_BAD_LIN_FIT does not correspond to an existing DQ mnemonic, so will be ignored
2025-09-13 12:52:46,571 - stdatamodels.dynamicdq - WARNING - Keyword UAZ_NO_WELL_SAMP does not correspond to an existing DQ mnemonic, so will be ignored
2025-09-13 12:52:46,572 - stdatamodels.dynamicdq - WARNING - Keyword UAZ_MODEL_FIT_FAIL does not correspond to an existing DQ mnemonic, so will be ignored
2025-09-13 12:52:46,572 - stdatamodels.dynamicdq - WARNING - Keyword UAZ_WELL_NOT_DEFINED does not correspond to an existing DQ mnemonic, so will be ignored
2025-09-13 12:52:46,573 - stdatamodels.dynamicdq - WARNING - Keyword UAZ_MASTER_MASK does not correspond to an existing DQ mnemonic, so will be ignored
2025-09-13 12:52:47,053 - stpipe.Detector1Pipeline.linearity - INFO - Step linearity done
2025-09-13 12:52:47,239 - stpipe.Detector1Pipeline.persistence - INFO - Step persistence running with args (<RampModel(1, 8, 2048, 2048) from jw02739001002_02105_00002_nrca2_uncal.fits>,).
2025-09-13 12:52:47,240 - stpipe.Detector1Pipeline.persistence - INFO - Step skipped.
2025-09-13 12:52:47,419 - stpipe.Detector1Pipeline.dark_current - INFO - Step dark_current running with args (<RampModel(1, 8, 2048, 2048) from jw02739001002_02105_00002_nrca2_uncal.fits>,).
2025-09-13 12:52:47,429 - stpipe.Detector1Pipeline.dark_current - INFO - Using DARK reference file /home/runner/crds/references/jwst/nircam/jwst_nircam_dark_0342.fits
2025-09-13 12:53:02,926 - stdatamodels.dynamicdq - WARNING - Keyword RESERVED_4 does not correspond to an existing DQ mnemonic, so will be ignored
2025-09-13 12:53:02,968 - stdatamodels.dynamicdq - WARNING - Keyword UNRELIABLE_RESET does not correspond to an existing DQ mnemonic, so will be ignored
2025-09-13 12:53:02,978 - stcal.dark_current.dark_sub - INFO - Science data nints=1, ngroups=8, nframes=1, groupgap=1
2025-09-13 12:53:02,979 - stcal.dark_current.dark_sub - INFO - Dark data nints=1, ngroups=187, nframes=1, groupgap=0
2025-09-13 12:53:04,138 - stpipe.Detector1Pipeline.dark_current - INFO - Step dark_current done
2025-09-13 12:53:04,373 - stpipe.Detector1Pipeline.charge_migration - INFO - Step charge_migration running with args (<RampModel(1, 8, 2048, 2048) from jw02739001002_02105_00002_nrca2_uncal.fits>,).
2025-09-13 12:53:04,374 - stpipe.Detector1Pipeline.charge_migration - INFO - Step skipped.
2025-09-13 12:53:04,554 - stpipe.Detector1Pipeline.jump - INFO - Step jump running with args (<RampModel(1, 8, 2048, 2048) from jw02739001002_02105_00002_nrca2_uncal.fits>,).
2025-09-13 12:53:04,561 - stpipe.Detector1Pipeline.jump - INFO - CR rejection threshold = 4 sigma
2025-09-13 12:53:04,562 - stpipe.Detector1Pipeline.jump - INFO - Maximum cores to use = half
2025-09-13 12:53:04,582 - stpipe.Detector1Pipeline.jump - INFO - Using GAIN reference file: /home/runner/crds/references/jwst/nircam/jwst_nircam_gain_0093.fits
2025-09-13 12:53:04,584 - stpipe.Detector1Pipeline.jump - INFO - Using READNOISE reference file: /home/runner/crds/references/jwst/nircam/jwst_nircam_readnoise_0224.fits
2025-09-13 12:53:04,700 - stcal.jump.jump - INFO - Executing two-point difference method
2025-09-13 12:53:04,701 - stcal.jump.jump - INFO - Creating 2 processes for jump detection 
2025-09-13 12:53:08,043 - stcal.jump.jump - INFO - Flagging Snowballs
2025-09-13 12:53:08,238 - stcal.jump.jump - INFO - Total snowballs = 60
2025-09-13 12:53:08,239 - stcal.jump.jump - INFO - Total elapsed time = 3.53822 sec
2025-09-13 12:53:08,276 - stpipe.Detector1Pipeline.jump - INFO - The execution time in seconds: 3.714770
2025-09-13 12:53:08,279 - stpipe.Detector1Pipeline.jump - INFO - Step jump done
2025-09-13 12:53:08,464 - stpipe.Detector1Pipeline.clean_flicker_noise - INFO - Step clean_flicker_noise running with args (<RampModel(1, 8, 2048, 2048) from jw02739001002_02105_00002_nrca2_uncal.fits>,).
2025-09-13 12:53:08,465 - stpipe.Detector1Pipeline.clean_flicker_noise - INFO - Step skipped.
2025-09-13 12:53:08,645 - stpipe.Detector1Pipeline.ramp_fit - INFO - Step ramp_fit running with args (<RampModel(1, 8, 2048, 2048) from jw02739001002_02105_00002_nrca2_uncal.fits>,).
2025-09-13 12:53:08,675 - jwst.ramp_fitting.ramp_fit_step - INFO - Using READNOISE reference file: /home/runner/crds/references/jwst/nircam/jwst_nircam_readnoise_0224.fits
2025-09-13 12:53:08,676 - jwst.ramp_fitting.ramp_fit_step - INFO - Using GAIN reference file: /home/runner/crds/references/jwst/nircam/jwst_nircam_gain_0093.fits
2025-09-13 12:53:08,701 - jwst.ramp_fitting.ramp_fit_step - INFO - Using algorithm = OLS_C
2025-09-13 12:53:08,702 - jwst.ramp_fitting.ramp_fit_step - INFO - Using weighting = optimal
2025-09-13 12:53:08,854 - stcal.ramp_fitting.ols_fit - INFO - Number of multiprocessing slices: 1
2025-09-13 12:53:11,419 - stcal.ramp_fitting.ols_fit - INFO - Ramp Fitting C Time: 2.561107635498047
2025-09-13 12:53:11,462 - stpipe.Detector1Pipeline.ramp_fit - INFO - Step ramp_fit done
2025-09-13 12:53:11,646 - stpipe.Detector1Pipeline.gain_scale - INFO - Step gain_scale running with args (<ImageModel(2048, 2048) from jw02739001002_02105_00002_nrca2_uncal.fits>,).
2025-09-13 12:53:11,666 - stpipe.Detector1Pipeline.gain_scale - INFO - GAINFACT not found in gain reference file
2025-09-13 12:53:11,666 - stpipe.Detector1Pipeline.gain_scale - INFO - Step will be skipped
2025-09-13 12:53:11,668 - stpipe.Detector1Pipeline.gain_scale - INFO - Step gain_scale done
2025-09-13 12:53:11,848 - stpipe.Detector1Pipeline.gain_scale - INFO - Step gain_scale running with args (<CubeModel(1, 2048, 2048) from jw02739001002_02105_00002_nrca2_uncal.fits>,).
2025-09-13 12:53:11,869 - stpipe.Detector1Pipeline.gain_scale - INFO - GAINFACT not found in gain reference file
2025-09-13 12:53:11,869 - stpipe.Detector1Pipeline.gain_scale - INFO - Step will be skipped
2025-09-13 12:53:11,871 - stpipe.Detector1Pipeline.gain_scale - INFO - Step gain_scale done
2025-09-13 12:53:11,981 - stpipe.Detector1Pipeline - INFO - Saved model in ./nrc_im_demo_data/Obs001/stage1/jw02739001002_02105_00002_nrca2_rateints.fits
2025-09-13 12:53:11,982 - jwst.pipeline.calwebb_detector1 - INFO - ... ending calwebb_detector1
2025-09-13 12:53:11,984 - jwst.stpipe.core - INFO - Results used CRDS context: jwst_1413.pmap
2025-09-13 12:53:12,093 - stpipe.Detector1Pipeline - INFO - Saved model in ./nrc_im_demo_data/Obs001/stage1/jw02739001002_02105_00002_nrca2_rate.fits
2025-09-13 12:53:12,094 - stpipe.Detector1Pipeline - INFO - Step Detector1Pipeline done
2025-09-13 12:53:12,094 - jwst.stpipe.core - INFO - Results used jwst version: 1.19.1
2025-09-13 12:53:12,126 - CRDS - ERROR -  Error determining best reference for 'pars-darkcurrentstep'  =   No match found.
2025-09-13 12:53:12,130 - stpipe - INFO - PARS-JUMPSTEP parameters found: /home/runner/crds/references/jwst/nircam/jwst_nircam_pars-jumpstep_0003.asdf
2025-09-13 12:53:12,141 - stpipe - INFO - PARS-DETECTOR1PIPELINE parameters found: /home/runner/crds/references/jwst/nircam/jwst_nircam_pars-detector1pipeline_0005.asdf
2025-09-13 12:53:12,158 - stpipe.Detector1Pipeline - INFO - Detector1Pipeline instance created.
2025-09-13 12:53:12,158 - stpipe.Detector1Pipeline.group_scale - INFO - GroupScaleStep instance created.
2025-09-13 12:53:12,159 - stpipe.Detector1Pipeline.dq_init - INFO - DQInitStep instance created.
2025-09-13 12:53:12,161 - stpipe.Detector1Pipeline.emicorr - INFO - EmiCorrStep instance created.
2025-09-13 12:53:12,162 - stpipe.Detector1Pipeline.saturation - INFO - SaturationStep instance created.
2025-09-13 12:53:12,163 - stpipe.Detector1Pipeline.ipc - INFO - IPCStep instance created.
2025-09-13 12:53:12,164 - stpipe.Detector1Pipeline.superbias - INFO - SuperBiasStep instance created.
2025-09-13 12:53:12,165 - stpipe.Detector1Pipeline.refpix - INFO - RefPixStep instance created.
2025-09-13 12:53:12,166 - stpipe.Detector1Pipeline.rscd - INFO - RscdStep instance created.
2025-09-13 12:53:12,167 - stpipe.Detector1Pipeline.firstframe - INFO - FirstFrameStep instance created.
2025-09-13 12:53:12,168 - stpipe.Detector1Pipeline.lastframe - INFO - LastFrameStep instance created.
2025-09-13 12:53:12,169 - stpipe.Detector1Pipeline.linearity - INFO - LinearityStep instance created.
2025-09-13 12:53:12,170 - stpipe.Detector1Pipeline.dark_current - INFO - DarkCurrentStep instance created.
2025-09-13 12:53:12,170 - stpipe.Detector1Pipeline.reset - INFO - ResetStep instance created.
2025-09-13 12:53:12,171 - stpipe.Detector1Pipeline.persistence - INFO - PersistenceStep instance created.
2025-09-13 12:53:12,172 - stpipe.Detector1Pipeline.charge_migration - INFO - ChargeMigrationStep instance created.
2025-09-13 12:53:12,174 - stpipe.Detector1Pipeline.jump - INFO - JumpStep instance created.
2025-09-13 12:53:12,175 - stpipe.Detector1Pipeline.clean_flicker_noise - INFO - CleanFlickerNoiseStep instance created.
2025-09-13 12:53:12,176 - stpipe.Detector1Pipeline.ramp_fit - INFO - RampFitStep instance created.
2025-09-13 12:53:12,177 - stpipe.Detector1Pipeline.gain_scale - INFO - GainScaleStep instance created.
2025-09-13 12:53:12,357 - stpipe.Detector1Pipeline - INFO - Step Detector1Pipeline running with args ('./nrc_im_demo_data/Obs001/uncal/jw02739001002_02105_00002_nrca4_uncal.fits',).
2025-09-13 12:53:12,378 - stpipe.Detector1Pipeline - INFO - Step Detector1Pipeline parameters are:
  pre_hooks: []
  post_hooks: []
  output_file: None
  output_dir: ./nrc_im_demo_data/Obs001/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: sirs
      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: True
      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: True
      suffix: None
      search_output_file: True
      input_dir: ''
      signal_threshold: 25000.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: half
      flag_4_neighbors: True
      max_jump_to_flag_neighbors: 1000
      min_jump_to_flag_neighbors: 30
      after_jump_flag_dn1: 0
      after_jump_flag_time1: 0
      after_jump_flag_dn2: 0
      after_jump_flag_time2: 0
      expand_large_events: True
      min_sat_area: 1
      min_jump_area: 5
      expand_factor: 2
      use_ellipses: False
      sat_required_snowball: True
      min_sat_radius_extend: 2.5
      sat_expand: 2
      edge_size: 25
      mask_snowball_core_next_int: True
      snowball_time_masked_next_int: 4000
      find_showers: False
      max_shower_amplitude: 4.0
      extend_snr_threshold: 0.0
      extend_min_area: 0
      extend_inner_radius: 0
      extend_outer_radius: 0.0
      extend_ellipse_expand_ratio: 0.0
      time_masked_after_shower: 0
      min_diffs_single_pass: 10
      max_extended_radius: 200
      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 12:53:12,397 - stpipe.Detector1Pipeline - INFO - Prefetching reference files for dataset: 'jw02739001002_02105_00002_nrca4_uncal.fits' reftypes = ['dark', 'gain', 'linearity', 'mask', 'readnoise', 'refpix', 'reset', 'rscd', 'saturation', 'sirskernel', 'superbias']
2025-09-13 12:53:12,400 - stpipe.Detector1Pipeline - INFO - Prefetch for DARK reference file is '/home/runner/crds/references/jwst/nircam/jwst_nircam_dark_0334.fits'.
2025-09-13 12:53:12,401 - stpipe.Detector1Pipeline - INFO - Prefetch for GAIN reference file is '/home/runner/crds/references/jwst/nircam/jwst_nircam_gain_0096.fits'.
2025-09-13 12:53:12,401 - stpipe.Detector1Pipeline - INFO - Prefetch for LINEARITY reference file is '/home/runner/crds/references/jwst/nircam/jwst_nircam_linearity_0055.fits'.
2025-09-13 12:53:12,402 - stpipe.Detector1Pipeline - INFO - Prefetch for MASK reference file is '/home/runner/crds/references/jwst/nircam/jwst_nircam_mask_0078.fits'.
2025-09-13 12:53:12,402 - stpipe.Detector1Pipeline - INFO - Prefetch for READNOISE reference file is '/home/runner/crds/references/jwst/nircam/jwst_nircam_readnoise_0248.fits'.
2025-09-13 12:53:12,403 - stpipe.Detector1Pipeline - INFO - Prefetch for REFPIX reference file is 'N/A'.
2025-09-13 12:53:12,403 - stpipe.Detector1Pipeline - INFO - Prefetch for RESET reference file is 'N/A'.
2025-09-13 12:53:12,404 - stpipe.Detector1Pipeline - INFO - Prefetch for RSCD reference file is 'N/A'.
2025-09-13 12:53:12,404 - stpipe.Detector1Pipeline - INFO - Prefetch for SATURATION reference file is '/home/runner/crds/references/jwst/nircam/jwst_nircam_saturation_0099.fits'.
2025-09-13 12:53:12,405 - stpipe.Detector1Pipeline - INFO - Prefetch for SIRSKERNEL reference file is '/home/runner/crds/references/jwst/nircam/jwst_nircam_sirskernel_0002.asdf'.
2025-09-13 12:53:12,405 - stpipe.Detector1Pipeline - INFO - Prefetch for SUPERBIAS reference file is '/home/runner/crds/references/jwst/nircam/jwst_nircam_superbias_0212.fits'.
2025-09-13 12:53:12,406 - jwst.pipeline.calwebb_detector1 - INFO - Starting calwebb_detector1 ...
2025-09-13 12:53:12,736 - stpipe.Detector1Pipeline.group_scale - INFO - Step group_scale running with args (<RampModel(1, 8, 2048, 2048) from jw02739001002_02105_00002_nrca4_uncal.fits>,).
2025-09-13 12:53:12,744 - stpipe.Detector1Pipeline.group_scale - INFO - NFRAMES and FRMDIVSR are equal; correction not needed
2025-09-13 12:53:12,744 - stpipe.Detector1Pipeline.group_scale - INFO - Step will be skipped
2025-09-13 12:53:12,746 - stpipe.Detector1Pipeline.group_scale - INFO - Step group_scale done
2025-09-13 12:53:12,921 - stpipe.Detector1Pipeline.dq_init - INFO - Step dq_init running with args (<RampModel(1, 8, 2048, 2048) from jw02739001002_02105_00002_nrca4_uncal.fits>,).
2025-09-13 12:53:12,930 - stpipe.Detector1Pipeline.dq_init - INFO - Using MASK reference file /home/runner/crds/references/jwst/nircam/jwst_nircam_mask_0078.fits
2025-09-13 12:53:13,092 - stpipe.Detector1Pipeline.dq_init - INFO - Step dq_init done
2025-09-13 12:53:13,273 - stpipe.Detector1Pipeline.saturation - INFO - Step saturation running with args (<RampModel(1, 8, 2048, 2048) from jw02739001002_02105_00002_nrca4_uncal.fits>,).
2025-09-13 12:53:13,284 - stpipe.Detector1Pipeline.saturation - INFO - Using SATURATION reference file /home/runner/crds/references/jwst/nircam/jwst_nircam_saturation_0099.fits
2025-09-13 12:53:13,284 - stpipe.Detector1Pipeline.saturation - INFO - Using SUPERBIAS reference file /home/runner/crds/references/jwst/nircam/jwst_nircam_superbias_0212.fits
2025-09-13 12:53:13,328 - stdatamodels.dynamicdq - WARNING - Keyword RESERVED_4 does not correspond to an existing DQ mnemonic, so will be ignored
2025-09-13 12:53:13,373 - stdatamodels.dynamicdq - WARNING - Keyword UNRELIABLE_RESET does not correspond to an existing DQ mnemonic, so will be ignored
2025-09-13 12:53:13,527 - jwst.saturation.saturation - INFO - Using read_pattern with nframes 1
2025-09-13 12:53:13,825 - stcal.saturation.saturation - INFO - Detected 4958 saturated pixels
2025-09-13 12:53:13,842 - stcal.saturation.saturation - INFO - Detected 1 A/D floor pixels
2025-09-13 12:53:13,848 - stpipe.Detector1Pipeline.saturation - INFO - Step saturation done
2025-09-13 12:53:14,024 - stpipe.Detector1Pipeline.ipc - INFO - Step ipc running with args (<RampModel(1, 8, 2048, 2048) from jw02739001002_02105_00002_nrca4_uncal.fits>,).
2025-09-13 12:53:14,025 - stpipe.Detector1Pipeline.ipc - INFO - Step skipped.
2025-09-13 12:53:14,200 - stpipe.Detector1Pipeline.superbias - INFO - Step superbias running with args (<RampModel(1, 8, 2048, 2048) from jw02739001002_02105_00002_nrca4_uncal.fits>,).
2025-09-13 12:53:14,209 - stpipe.Detector1Pipeline.superbias - INFO - Using SUPERBIAS reference file /home/runner/crds/references/jwst/nircam/jwst_nircam_superbias_0212.fits
2025-09-13 12:53:14,418 - stpipe.Detector1Pipeline.superbias - INFO - Step superbias done
2025-09-13 12:53:14,602 - stpipe.Detector1Pipeline.refpix - INFO - Step refpix running with args (<RampModel(1, 8, 2048, 2048) from jw02739001002_02105_00002_nrca4_uncal.fits>,).
2025-09-13 12:53:14,635 - stpipe.Detector1Pipeline.refpix - INFO - Using SIRS reference file: /home/runner/crds/references/jwst/nircam/jwst_nircam_sirskernel_0002.asdf
2025-09-13 12:53:14,654 - jwst.refpix.reference_pixels - INFO - NIR full frame data
2025-09-13 12:53:14,654 - jwst.refpix.reference_pixels - INFO - The following parameters are valid for this mode:
2025-09-13 12:53:14,655 - jwst.refpix.reference_pixels - INFO - sigreject = 4.0
2025-09-13 12:53:14,655 - jwst.refpix.reference_pixels - INFO - gaussmooth = 1.0
2025-09-13 12:53:14,656 - jwst.refpix.reference_pixels - INFO - halfwidth = 30
2025-09-13 12:53:14,964 - stpipe.Detector1Pipeline.refpix - INFO - Step refpix done
2025-09-13 12:53:15,143 - stpipe.Detector1Pipeline.linearity - INFO - Step linearity running with args (<RampModel(1, 8, 2048, 2048) from jw02739001002_02105_00002_nrca4_uncal.fits>,).
2025-09-13 12:53:15,152 - stpipe.Detector1Pipeline.linearity - INFO - Using Linearity reference file /home/runner/crds/references/jwst/nircam/jwst_nircam_linearity_0055.fits
2025-09-13 12:53:15,213 - stdatamodels.dynamicdq - WARNING - Keyword UAZ_DO_NOT_USE does not correspond to an existing DQ mnemonic, so will be ignored
2025-09-13 12:53:15,214 - stdatamodels.dynamicdq - WARNING - Keyword UAZ_NO_LIN_SAMP does not correspond to an existing DQ mnemonic, so will be ignored
2025-09-13 12:53:15,215 - stdatamodels.dynamicdq - WARNING - Keyword UAZ_BAD_LIN_FIT does not correspond to an existing DQ mnemonic, so will be ignored
2025-09-13 12:53:15,216 - stdatamodels.dynamicdq - WARNING - Keyword UAZ_NO_WELL_SAMP does not correspond to an existing DQ mnemonic, so will be ignored
2025-09-13 12:53:15,216 - stdatamodels.dynamicdq - WARNING - Keyword UAZ_MODEL_FIT_FAIL does not correspond to an existing DQ mnemonic, so will be ignored
2025-09-13 12:53:15,217 - stdatamodels.dynamicdq - WARNING - Keyword UAZ_WELL_NOT_DEFINED does not correspond to an existing DQ mnemonic, so will be ignored
2025-09-13 12:53:15,217 - stdatamodels.dynamicdq - WARNING - Keyword UAZ_MASTER_MASK does not correspond to an existing DQ mnemonic, so will be ignored
2025-09-13 12:53:15,737 - stpipe.Detector1Pipeline.linearity - INFO - Step linearity done
2025-09-13 12:53:15,915 - stpipe.Detector1Pipeline.persistence - INFO - Step persistence running with args (<RampModel(1, 8, 2048, 2048) from jw02739001002_02105_00002_nrca4_uncal.fits>,).
2025-09-13 12:53:15,915 - stpipe.Detector1Pipeline.persistence - INFO - Step skipped.
2025-09-13 12:53:16,088 - stpipe.Detector1Pipeline.dark_current - INFO - Step dark_current running with args (<RampModel(1, 8, 2048, 2048) from jw02739001002_02105_00002_nrca4_uncal.fits>,).
2025-09-13 12:53:16,098 - stpipe.Detector1Pipeline.dark_current - INFO - Using DARK reference file /home/runner/crds/references/jwst/nircam/jwst_nircam_dark_0334.fits
2025-09-13 12:53:28,611 - stdatamodels.dynamicdq - WARNING - Keyword RESERVED_4 does not correspond to an existing DQ mnemonic, so will be ignored
2025-09-13 12:53:28,653 - stdatamodels.dynamicdq - WARNING - Keyword UNRELIABLE_RESET does not correspond to an existing DQ mnemonic, so will be ignored
2025-09-13 12:53:28,664 - stcal.dark_current.dark_sub - INFO - Science data nints=1, ngroups=8, nframes=1, groupgap=1
2025-09-13 12:53:28,664 - stcal.dark_current.dark_sub - INFO - Dark data nints=1, ngroups=187, nframes=1, groupgap=0
2025-09-13 12:53:29,724 - stpipe.Detector1Pipeline.dark_current - INFO - Step dark_current done
2025-09-13 12:53:29,980 - stpipe.Detector1Pipeline.charge_migration - INFO - Step charge_migration running with args (<RampModel(1, 8, 2048, 2048) from jw02739001002_02105_00002_nrca4_uncal.fits>,).
2025-09-13 12:53:29,981 - stpipe.Detector1Pipeline.charge_migration - INFO - Step skipped.
2025-09-13 12:53:30,156 - stpipe.Detector1Pipeline.jump - INFO - Step jump running with args (<RampModel(1, 8, 2048, 2048) from jw02739001002_02105_00002_nrca4_uncal.fits>,).
2025-09-13 12:53:30,164 - stpipe.Detector1Pipeline.jump - INFO - CR rejection threshold = 4 sigma
2025-09-13 12:53:30,164 - stpipe.Detector1Pipeline.jump - INFO - Maximum cores to use = half
2025-09-13 12:53:30,191 - stpipe.Detector1Pipeline.jump - INFO - Using GAIN reference file: /home/runner/crds/references/jwst/nircam/jwst_nircam_gain_0096.fits
2025-09-13 12:53:30,194 - stpipe.Detector1Pipeline.jump - INFO - Using READNOISE reference file: /home/runner/crds/references/jwst/nircam/jwst_nircam_readnoise_0248.fits
2025-09-13 12:53:30,310 - stcal.jump.jump - INFO - Executing two-point difference method
2025-09-13 12:53:30,311 - stcal.jump.jump - INFO - Creating 2 processes for jump detection 
2025-09-13 12:53:33,514 - stcal.jump.jump - INFO - Flagging Snowballs
2025-09-13 12:53:33,665 - stcal.jump.jump - INFO - Total snowballs = 84
2025-09-13 12:53:33,666 - stcal.jump.jump - INFO - Total elapsed time = 3.35492 sec
2025-09-13 12:53:33,703 - stpipe.Detector1Pipeline.jump - INFO - The execution time in seconds: 3.538997
2025-09-13 12:53:33,706 - stpipe.Detector1Pipeline.jump - INFO - Step jump done
2025-09-13 12:53:33,884 - stpipe.Detector1Pipeline.clean_flicker_noise - INFO - Step clean_flicker_noise running with args (<RampModel(1, 8, 2048, 2048) from jw02739001002_02105_00002_nrca4_uncal.fits>,).
2025-09-13 12:53:33,885 - stpipe.Detector1Pipeline.clean_flicker_noise - INFO - Step skipped.
2025-09-13 12:53:34,058 - stpipe.Detector1Pipeline.ramp_fit - INFO - Step ramp_fit running with args (<RampModel(1, 8, 2048, 2048) from jw02739001002_02105_00002_nrca4_uncal.fits>,).
2025-09-13 12:53:34,116 - jwst.ramp_fitting.ramp_fit_step - INFO - Using READNOISE reference file: /home/runner/crds/references/jwst/nircam/jwst_nircam_readnoise_0248.fits
2025-09-13 12:53:34,117 - jwst.ramp_fitting.ramp_fit_step - INFO - Using GAIN reference file: /home/runner/crds/references/jwst/nircam/jwst_nircam_gain_0096.fits
2025-09-13 12:53:34,142 - jwst.ramp_fitting.ramp_fit_step - INFO - Using algorithm = OLS_C
2025-09-13 12:53:34,142 - jwst.ramp_fitting.ramp_fit_step - INFO - Using weighting = optimal
2025-09-13 12:53:34,265 - stcal.ramp_fitting.ols_fit - INFO - Number of multiprocessing slices: 1
2025-09-13 12:53:36,863 - stcal.ramp_fitting.ols_fit - INFO - Ramp Fitting C Time: 2.594015121459961
2025-09-13 12:53:36,905 - stpipe.Detector1Pipeline.ramp_fit - INFO - Step ramp_fit done
2025-09-13 12:53:37,079 - stpipe.Detector1Pipeline.gain_scale - INFO - Step gain_scale running with args (<ImageModel(2048, 2048) from jw02739001002_02105_00002_nrca4_uncal.fits>,).
2025-09-13 12:53:37,098 - stpipe.Detector1Pipeline.gain_scale - INFO - GAINFACT not found in gain reference file
2025-09-13 12:53:37,099 - stpipe.Detector1Pipeline.gain_scale - INFO - Step will be skipped
2025-09-13 12:53:37,101 - stpipe.Detector1Pipeline.gain_scale - INFO - Step gain_scale done
2025-09-13 12:53:37,275 - stpipe.Detector1Pipeline.gain_scale - INFO - Step gain_scale running with args (<CubeModel(1, 2048, 2048) from jw02739001002_02105_00002_nrca4_uncal.fits>,).
2025-09-13 12:53:37,295 - stpipe.Detector1Pipeline.gain_scale - INFO - GAINFACT not found in gain reference file
2025-09-13 12:53:37,296 - stpipe.Detector1Pipeline.gain_scale - INFO - Step will be skipped
2025-09-13 12:53:37,298 - stpipe.Detector1Pipeline.gain_scale - INFO - Step gain_scale done
2025-09-13 12:53:37,407 - stpipe.Detector1Pipeline - INFO - Saved model in ./nrc_im_demo_data/Obs001/stage1/jw02739001002_02105_00002_nrca4_rateints.fits
2025-09-13 12:53:37,408 - jwst.pipeline.calwebb_detector1 - INFO - ... ending calwebb_detector1
2025-09-13 12:53:37,410 - jwst.stpipe.core - INFO - Results used CRDS context: jwst_1413.pmap
2025-09-13 12:53:37,519 - stpipe.Detector1Pipeline - INFO - Saved model in ./nrc_im_demo_data/Obs001/stage1/jw02739001002_02105_00002_nrca4_rate.fits
2025-09-13 12:53:37,520 - stpipe.Detector1Pipeline - INFO - Step Detector1Pipeline done
2025-09-13 12:53:37,520 - jwst.stpipe.core - INFO - Results used jwst version: 1.19.1
2025-09-13 12:53:37,551 - CRDS - ERROR -  Error determining best reference for 'pars-darkcurrentstep'  =   No match found.
2025-09-13 12:53:37,555 - stpipe - INFO - PARS-JUMPSTEP parameters found: /home/runner/crds/references/jwst/nircam/jwst_nircam_pars-jumpstep_0003.asdf
2025-09-13 12:53:37,566 - stpipe - INFO - PARS-DETECTOR1PIPELINE parameters found: /home/runner/crds/references/jwst/nircam/jwst_nircam_pars-detector1pipeline_0005.asdf
2025-09-13 12:53:37,582 - stpipe.Detector1Pipeline - INFO - Detector1Pipeline instance created.
2025-09-13 12:53:37,583 - stpipe.Detector1Pipeline.group_scale - INFO - GroupScaleStep instance created.
2025-09-13 12:53:37,583 - stpipe.Detector1Pipeline.dq_init - INFO - DQInitStep instance created.
2025-09-13 12:53:37,585 - stpipe.Detector1Pipeline.emicorr - INFO - EmiCorrStep instance created.
2025-09-13 12:53:37,585 - stpipe.Detector1Pipeline.saturation - INFO - SaturationStep instance created.
2025-09-13 12:53:37,586 - stpipe.Detector1Pipeline.ipc - INFO - IPCStep instance created.
2025-09-13 12:53:37,587 - stpipe.Detector1Pipeline.superbias - INFO - SuperBiasStep instance created.
2025-09-13 12:53:37,588 - stpipe.Detector1Pipeline.refpix - INFO - RefPixStep instance created.
2025-09-13 12:53:37,589 - stpipe.Detector1Pipeline.rscd - INFO - RscdStep instance created.
2025-09-13 12:53:37,589 - stpipe.Detector1Pipeline.firstframe - INFO - FirstFrameStep instance created.
2025-09-13 12:53:37,591 - stpipe.Detector1Pipeline.lastframe - INFO - LastFrameStep instance created.
2025-09-13 12:53:37,592 - stpipe.Detector1Pipeline.linearity - INFO - LinearityStep instance created.
2025-09-13 12:53:37,593 - stpipe.Detector1Pipeline.dark_current - INFO - DarkCurrentStep instance created.
2025-09-13 12:53:37,594 - stpipe.Detector1Pipeline.reset - INFO - ResetStep instance created.
2025-09-13 12:53:37,595 - stpipe.Detector1Pipeline.persistence - INFO - PersistenceStep instance created.
2025-09-13 12:53:37,595 - stpipe.Detector1Pipeline.charge_migration - INFO - ChargeMigrationStep instance created.
2025-09-13 12:53:37,597 - stpipe.Detector1Pipeline.jump - INFO - JumpStep instance created.
2025-09-13 12:53:37,598 - stpipe.Detector1Pipeline.clean_flicker_noise - INFO - CleanFlickerNoiseStep instance created.
2025-09-13 12:53:37,599 - stpipe.Detector1Pipeline.ramp_fit - INFO - RampFitStep instance created.
2025-09-13 12:53:37,600 - stpipe.Detector1Pipeline.gain_scale - INFO - GainScaleStep instance created.
2025-09-13 12:53:37,780 - stpipe.Detector1Pipeline - INFO - Step Detector1Pipeline running with args ('./nrc_im_demo_data/Obs001/uncal/jw02739001002_02105_00002_nrcalong_uncal.fits',).
2025-09-13 12:53:37,801 - stpipe.Detector1Pipeline - INFO - Step Detector1Pipeline parameters are:
  pre_hooks: []
  post_hooks: []
  output_file: None
  output_dir: ./nrc_im_demo_data/Obs001/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: sirs
      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: True
      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: True
      suffix: None
      search_output_file: True
      input_dir: ''
      signal_threshold: 25000.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: half
      flag_4_neighbors: True
      max_jump_to_flag_neighbors: 1000
      min_jump_to_flag_neighbors: 30
      after_jump_flag_dn1: 0
      after_jump_flag_time1: 0
      after_jump_flag_dn2: 0
      after_jump_flag_time2: 0
      expand_large_events: True
      min_sat_area: 1
      min_jump_area: 5
      expand_factor: 2
      use_ellipses: False
      sat_required_snowball: True
      min_sat_radius_extend: 2.5
      sat_expand: 2
      edge_size: 25
      mask_snowball_core_next_int: True
      snowball_time_masked_next_int: 4000
      find_showers: False
      max_shower_amplitude: 4.0
      extend_snr_threshold: 0.0
      extend_min_area: 0
      extend_inner_radius: 0
      extend_outer_radius: 0.0
      extend_ellipse_expand_ratio: 0.0
      time_masked_after_shower: 0
      min_diffs_single_pass: 10
      max_extended_radius: 200
      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 12:53:37,820 - stpipe.Detector1Pipeline - INFO - Prefetching reference files for dataset: 'jw02739001002_02105_00002_nrcalong_uncal.fits' reftypes = ['dark', 'gain', 'linearity', 'mask', 'readnoise', 'refpix', 'reset', 'rscd', 'saturation', 'sirskernel', 'superbias']
2025-09-13 12:53:37,823 - stpipe.Detector1Pipeline - INFO - Prefetch for DARK reference file is '/home/runner/crds/references/jwst/nircam/jwst_nircam_dark_0424.fits'.
2025-09-13 12:53:37,824 - stpipe.Detector1Pipeline - INFO - Prefetch for GAIN reference file is '/home/runner/crds/references/jwst/nircam/jwst_nircam_gain_0097.fits'.
2025-09-13 12:53:37,824 - stpipe.Detector1Pipeline - INFO - Prefetch for LINEARITY reference file is '/home/runner/crds/references/jwst/nircam/jwst_nircam_linearity_0052.fits'.
2025-09-13 12:53:37,824 - stpipe.Detector1Pipeline - INFO - Prefetch for MASK reference file is '/home/runner/crds/references/jwst/nircam/jwst_nircam_mask_0076.fits'.
2025-09-13 12:53:37,825 - stpipe.Detector1Pipeline - INFO - Prefetch for READNOISE reference file is '/home/runner/crds/references/jwst/nircam/jwst_nircam_readnoise_0266.fits'.
2025-09-13 12:53:37,826 - stpipe.Detector1Pipeline - INFO - Prefetch for REFPIX reference file is 'N/A'.
2025-09-13 12:53:37,826 - stpipe.Detector1Pipeline - INFO - Prefetch for RESET reference file is 'N/A'.
2025-09-13 12:53:37,826 - stpipe.Detector1Pipeline - INFO - Prefetch for RSCD reference file is 'N/A'.
2025-09-13 12:53:37,827 - stpipe.Detector1Pipeline - INFO - Prefetch for SATURATION reference file is '/home/runner/crds/references/jwst/nircam/jwst_nircam_saturation_0097.fits'.
2025-09-13 12:53:37,828 - stpipe.Detector1Pipeline - INFO - Prefetch for SIRSKERNEL reference file is '/home/runner/crds/references/jwst/nircam/jwst_nircam_sirskernel_0002.asdf'.
2025-09-13 12:53:37,828 - stpipe.Detector1Pipeline - INFO - Prefetch for SUPERBIAS reference file is '/home/runner/crds/references/jwst/nircam/jwst_nircam_superbias_0220.fits'.
2025-09-13 12:53:37,829 - jwst.pipeline.calwebb_detector1 - INFO - Starting calwebb_detector1 ...
2025-09-13 12:53:38,157 - stpipe.Detector1Pipeline.group_scale - INFO - Step group_scale running with args (<RampModel(1, 8, 2048, 2048) from jw02739001002_02105_00002_nrcalong_uncal.fits>,).
2025-09-13 12:53:38,164 - stpipe.Detector1Pipeline.group_scale - INFO - NFRAMES and FRMDIVSR are equal; correction not needed
2025-09-13 12:53:38,165 - stpipe.Detector1Pipeline.group_scale - INFO - Step will be skipped
2025-09-13 12:53:38,166 - stpipe.Detector1Pipeline.group_scale - INFO - Step group_scale done
2025-09-13 12:53:38,338 - stpipe.Detector1Pipeline.dq_init - INFO - Step dq_init running with args (<RampModel(1, 8, 2048, 2048) from jw02739001002_02105_00002_nrcalong_uncal.fits>,).
2025-09-13 12:53:38,347 - stpipe.Detector1Pipeline.dq_init - INFO - Using MASK reference file /home/runner/crds/references/jwst/nircam/jwst_nircam_mask_0076.fits
2025-09-13 12:53:38,554 - stpipe.Detector1Pipeline.dq_init - INFO - Step dq_init done
2025-09-13 12:53:38,737 - stpipe.Detector1Pipeline.saturation - INFO - Step saturation running with args (<RampModel(1, 8, 2048, 2048) from jw02739001002_02105_00002_nrcalong_uncal.fits>,).
2025-09-13 12:53:38,748 - stpipe.Detector1Pipeline.saturation - INFO - Using SATURATION reference file /home/runner/crds/references/jwst/nircam/jwst_nircam_saturation_0097.fits
2025-09-13 12:53:38,748 - stpipe.Detector1Pipeline.saturation - INFO - Using SUPERBIAS reference file /home/runner/crds/references/jwst/nircam/jwst_nircam_superbias_0220.fits
2025-09-13 12:53:38,805 - stdatamodels.dynamicdq - WARNING - Keyword RESERVED_4 does not correspond to an existing DQ mnemonic, so will be ignored
2025-09-13 12:53:38,849 - stdatamodels.dynamicdq - WARNING - Keyword UNRELIABLE_RESET does not correspond to an existing DQ mnemonic, so will be ignored
2025-09-13 12:53:38,999 - jwst.saturation.saturation - INFO - Using read_pattern with nframes 1
2025-09-13 12:53:39,235 - stcal.saturation.saturation - INFO - Detected 26763 saturated pixels
2025-09-13 12:53:39,249 - stcal.saturation.saturation - INFO - Detected 0 A/D floor pixels
2025-09-13 12:53:39,255 - stpipe.Detector1Pipeline.saturation - INFO - Step saturation done
2025-09-13 12:53:39,439 - stpipe.Detector1Pipeline.ipc - INFO - Step ipc running with args (<RampModel(1, 8, 2048, 2048) from jw02739001002_02105_00002_nrcalong_uncal.fits>,).
2025-09-13 12:53:39,439 - stpipe.Detector1Pipeline.ipc - INFO - Step skipped.
2025-09-13 12:53:39,619 - stpipe.Detector1Pipeline.superbias - INFO - Step superbias running with args (<RampModel(1, 8, 2048, 2048) from jw02739001002_02105_00002_nrcalong_uncal.fits>,).
2025-09-13 12:53:39,629 - stpipe.Detector1Pipeline.superbias - INFO - Using SUPERBIAS reference file /home/runner/crds/references/jwst/nircam/jwst_nircam_superbias_0220.fits
2025-09-13 12:53:39,867 - stpipe.Detector1Pipeline.superbias - INFO - Step superbias done
2025-09-13 12:53:40,057 - stpipe.Detector1Pipeline.refpix - INFO - Step refpix running with args (<RampModel(1, 8, 2048, 2048) from jw02739001002_02105_00002_nrcalong_uncal.fits>,).
2025-09-13 12:53:40,083 - stpipe.Detector1Pipeline.refpix - INFO - Using SIRS reference file: /home/runner/crds/references/jwst/nircam/jwst_nircam_sirskernel_0002.asdf
2025-09-13 12:53:40,101 - jwst.refpix.reference_pixels - INFO - NIR full frame data
2025-09-13 12:53:40,101 - jwst.refpix.reference_pixels - INFO - The following parameters are valid for this mode:
2025-09-13 12:53:40,102 - jwst.refpix.reference_pixels - INFO - sigreject = 4.0
2025-09-13 12:53:40,102 - jwst.refpix.reference_pixels - INFO - gaussmooth = 1.0
2025-09-13 12:53:40,103 - jwst.refpix.reference_pixels - INFO - halfwidth = 30
2025-09-13 12:53:40,377 - stpipe.Detector1Pipeline.refpix - INFO - Step refpix done
2025-09-13 12:53:40,564 - stpipe.Detector1Pipeline.linearity - INFO - Step linearity running with args (<RampModel(1, 8, 2048, 2048) from jw02739001002_02105_00002_nrcalong_uncal.fits>,).
2025-09-13 12:53:40,573 - stpipe.Detector1Pipeline.linearity - INFO - Using Linearity reference file /home/runner/crds/references/jwst/nircam/jwst_nircam_linearity_0052.fits
2025-09-13 12:53:40,683 - stdatamodels.dynamicdq - WARNING - Keyword UAZ_DO_NOT_USE does not correspond to an existing DQ mnemonic, so will be ignored
2025-09-13 12:53:40,684 - stdatamodels.dynamicdq - WARNING - Keyword UAZ_NO_LIN_SAMP does not correspond to an existing DQ mnemonic, so will be ignored
2025-09-13 12:53:40,685 - stdatamodels.dynamicdq - WARNING - Keyword UAZ_BAD_LIN_FIT does not correspond to an existing DQ mnemonic, so will be ignored
2025-09-13 12:53:40,685 - stdatamodels.dynamicdq - WARNING - Keyword UAZ_NO_WELL_SAMP does not correspond to an existing DQ mnemonic, so will be ignored
2025-09-13 12:53:40,686 - stdatamodels.dynamicdq - WARNING - Keyword UAZ_MODEL_FIT_FAIL does not correspond to an existing DQ mnemonic, so will be ignored
2025-09-13 12:53:40,687 - stdatamodels.dynamicdq - WARNING - Keyword UAZ_WELL_NOT_DEFINED does not correspond to an existing DQ mnemonic, so will be ignored
2025-09-13 12:53:40,687 - stdatamodels.dynamicdq - WARNING - Keyword UAZ_MASTER_MASK does not correspond to an existing DQ mnemonic, so will be ignored
2025-09-13 12:53:41,215 - stpipe.Detector1Pipeline.linearity - INFO - Step linearity done
2025-09-13 12:53:41,397 - stpipe.Detector1Pipeline.persistence - INFO - Step persistence running with args (<RampModel(1, 8, 2048, 2048) from jw02739001002_02105_00002_nrcalong_uncal.fits>,).
2025-09-13 12:53:41,398 - stpipe.Detector1Pipeline.persistence - INFO - Step skipped.
2025-09-13 12:53:41,575 - stpipe.Detector1Pipeline.dark_current - INFO - Step dark_current running with args (<RampModel(1, 8, 2048, 2048) from jw02739001002_02105_00002_nrcalong_uncal.fits>,).
2025-09-13 12:53:41,585 - stpipe.Detector1Pipeline.dark_current - INFO - Using DARK reference file /home/runner/crds/references/jwst/nircam/jwst_nircam_dark_0424.fits
2025-09-13 12:53:52,225 - stcal.dark_current.dark_sub - INFO - Science data nints=1, ngroups=8, nframes=1, groupgap=1
2025-09-13 12:53:52,226 - stcal.dark_current.dark_sub - INFO - Dark data nints=1, ngroups=130, nframes=1, groupgap=0
2025-09-13 12:53:52,840 - stpipe.Detector1Pipeline.dark_current - INFO - Step dark_current done
2025-09-13 12:53:53,059 - stpipe.Detector1Pipeline.charge_migration - INFO - Step charge_migration running with args (<RampModel(1, 8, 2048, 2048) from jw02739001002_02105_00002_nrcalong_uncal.fits>,).
2025-09-13 12:53:53,060 - stpipe.Detector1Pipeline.charge_migration - INFO - Step skipped.
2025-09-13 12:53:53,243 - stpipe.Detector1Pipeline.jump - INFO - Step jump running with args (<RampModel(1, 8, 2048, 2048) from jw02739001002_02105_00002_nrcalong_uncal.fits>,).
2025-09-13 12:53:53,251 - stpipe.Detector1Pipeline.jump - INFO - CR rejection threshold = 4 sigma
2025-09-13 12:53:53,251 - stpipe.Detector1Pipeline.jump - INFO - Maximum cores to use = half
2025-09-13 12:53:53,272 - stpipe.Detector1Pipeline.jump - INFO - Using GAIN reference file: /home/runner/crds/references/jwst/nircam/jwst_nircam_gain_0097.fits
2025-09-13 12:53:53,274 - stpipe.Detector1Pipeline.jump - INFO - Using READNOISE reference file: /home/runner/crds/references/jwst/nircam/jwst_nircam_readnoise_0266.fits
2025-09-13 12:53:53,396 - stcal.jump.jump - INFO - Executing two-point difference method
2025-09-13 12:53:53,396 - stcal.jump.jump - INFO - Creating 2 processes for jump detection 
2025-09-13 12:53:56,985 - stcal.jump.jump - INFO - Flagging Snowballs
2025-09-13 12:53:57,606 - stcal.jump.jump - INFO - Total snowballs = 205
2025-09-13 12:53:57,607 - stcal.jump.jump - INFO - Total elapsed time = 4.21098 sec
2025-09-13 12:53:57,644 - stpipe.Detector1Pipeline.jump - INFO - The execution time in seconds: 4.393484
2025-09-13 12:53:57,647 - stpipe.Detector1Pipeline.jump - INFO - Step jump done
2025-09-13 12:53:57,819 - stpipe.Detector1Pipeline.clean_flicker_noise - INFO - Step clean_flicker_noise running with args (<RampModel(1, 8, 2048, 2048) from jw02739001002_02105_00002_nrcalong_uncal.fits>,).
2025-09-13 12:53:57,820 - stpipe.Detector1Pipeline.clean_flicker_noise - INFO - Step skipped.
2025-09-13 12:53:57,997 - stpipe.Detector1Pipeline.ramp_fit - INFO - Step ramp_fit running with args (<RampModel(1, 8, 2048, 2048) from jw02739001002_02105_00002_nrcalong_uncal.fits>,).
2025-09-13 12:53:58,027 - jwst.ramp_fitting.ramp_fit_step - INFO - Using READNOISE reference file: /home/runner/crds/references/jwst/nircam/jwst_nircam_readnoise_0266.fits
2025-09-13 12:53:58,028 - jwst.ramp_fitting.ramp_fit_step - INFO - Using GAIN reference file: /home/runner/crds/references/jwst/nircam/jwst_nircam_gain_0097.fits
2025-09-13 12:53:58,053 - jwst.ramp_fitting.ramp_fit_step - INFO - Using algorithm = OLS_C
2025-09-13 12:53:58,054 - jwst.ramp_fitting.ramp_fit_step - INFO - Using weighting = optimal
2025-09-13 12:53:58,277 - stcal.ramp_fitting.ols_fit - INFO - Number of multiprocessing slices: 1
2025-09-13 12:54:00,822 - stcal.ramp_fitting.ols_fit - INFO - Ramp Fitting C Time: 2.5407347679138184
2025-09-13 12:54:00,863 - stpipe.Detector1Pipeline.ramp_fit - INFO - Step ramp_fit done
2025-09-13 12:54:01,041 - stpipe.Detector1Pipeline.gain_scale - INFO - Step gain_scale running with args (<ImageModel(2048, 2048) from jw02739001002_02105_00002_nrcalong_uncal.fits>,).
2025-09-13 12:54:01,061 - stpipe.Detector1Pipeline.gain_scale - INFO - GAINFACT not found in gain reference file
2025-09-13 12:54:01,062 - stpipe.Detector1Pipeline.gain_scale - INFO - Step will be skipped
2025-09-13 12:54:01,064 - stpipe.Detector1Pipeline.gain_scale - INFO - Step gain_scale done
2025-09-13 12:54:01,245 - stpipe.Detector1Pipeline.gain_scale - INFO - Step gain_scale running with args (<CubeModel(1, 2048, 2048) from jw02739001002_02105_00002_nrcalong_uncal.fits>,).
2025-09-13 12:54:01,265 - stpipe.Detector1Pipeline.gain_scale - INFO - GAINFACT not found in gain reference file
2025-09-13 12:54:01,265 - stpipe.Detector1Pipeline.gain_scale - INFO - Step will be skipped
2025-09-13 12:54:01,267 - stpipe.Detector1Pipeline.gain_scale - INFO - Step gain_scale done
2025-09-13 12:54:01,377 - stpipe.Detector1Pipeline - INFO - Saved model in ./nrc_im_demo_data/Obs001/stage1/jw02739001002_02105_00002_nrcalong_rateints.fits
2025-09-13 12:54:01,378 - jwst.pipeline.calwebb_detector1 - INFO - ... ending calwebb_detector1
2025-09-13 12:54:01,379 - jwst.stpipe.core - INFO - Results used CRDS context: jwst_1413.pmap
2025-09-13 12:54:01,489 - stpipe.Detector1Pipeline - INFO - Saved model in ./nrc_im_demo_data/Obs001/stage1/jw02739001002_02105_00002_nrcalong_rate.fits
2025-09-13 12:54:01,489 - stpipe.Detector1Pipeline - INFO - Step Detector1Pipeline done
2025-09-13 12:54:01,490 - jwst.stpipe.core - INFO - Results used jwst version: 1.19.1
# Print out the time benchmark
time1 = time.perf_counter()
print(f"Runtime so far: {time1 - time0:0.0f} seconds")
print(f"Runtime for Detector1: {time1 - time_det1:0.0f} seconds")
Runtime so far: 384 seconds
Runtime for Detector1: 368 seconds

Exploring the data#

Identify *_rate.fits files and verify which pipeline steps were run and which calibration reference files were applied.

The header contains information about which calibration steps were completed and skipped and which reference files were used to process the data.

if dodet1:
    # find rate files
    rate_files = sorted(glob.glob(os.path.join(det1_dir, '*_rate.fits')))

    # Read in file as datamodel
    rate_f = datamodels.open(rate_files[0])

    # Check which steps were run
    rate_f.meta.cal_step.instance
{'charge_migration': 'SKIPPED',
 'clean_flicker_noise': 'SKIPPED',
 'dark_sub': 'COMPLETE',
 'dq_init': 'COMPLETE',
 'gain_scale': 'SKIPPED',
 'group_scale': 'SKIPPED',
 'ipc': 'SKIPPED',
 'jump': 'COMPLETE',
 'linearity': 'COMPLETE',
 'persistence': 'SKIPPED',
 'ramp_fit': 'COMPLETE',
 'refpix': 'COMPLETE',
 'saturation': 'COMPLETE',
 'superbias': 'COMPLETE'}

For this particular rate file, show which reference files were used to calibrate the dataset. Note that these files will be different for each NIRCam detector.

if dodet1:
    rate_f.meta.ref_file.instance
{'crds': {'context_used': 'jwst_1413.pmap', 'sw_version': '13.0.4'},
 'dark': {'name': 'crds://jwst_nircam_dark_0342.fits'},
 'gain': {'name': 'crds://jwst_nircam_gain_0093.fits'},
 'linearity': {'name': 'crds://jwst_nircam_linearity_0051.fits'},
 'mask': {'name': 'crds://jwst_nircam_mask_0072.fits'},
 'readnoise': {'name': 'crds://jwst_nircam_readnoise_0224.fits'},
 'saturation': {'name': 'crds://jwst_nircam_saturation_0104.fits'},
 'sirskernel': {'name': 'crds://jwst_nircam_sirskernel_0002.asdf'},
 'superbias': {'name': 'crds://jwst_nircam_superbias_0186.fits'}}

6. Image2 Pipeline#

In the Image2 stage of the pipeline, calibrated unrectified data products are created (*_cal.fits or *_calints.fits files, depending on whether the input files are *_rate.fits or *_rateints.fits).

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 turned off for NIRCam. The background subtraction is turned off since there is no background template for the imaging mode and the local background is subtracted as part of the photometry perfoemd in the source catalog step in the Image3 pipeline.

The resampling step occurs during the Image3 stage by default.

While the resampling step can be run on individual images in the Image2 stage, e.g., to prepare for generating a source catalog for each image, the default behavior is to run the step only in the Image3 stage, where multiple images are combined into a final mosaic after the outlier detection step flags bad pixels.

To turn on the resampling step in the Image2 stage, uncomment the line in the dicitionary below which sets image2dict['resample']['skip'] = False

time_image2 = time.perf_counter()
# Set up a dictionary to define how the Image2 pipeline should be configured.

# Boilerplate dictionary setup
image2dict = {}
image2dict['assign_wcs'], image2dict['flat_field'] = {}, {}
image2dict['photom'], image2dict['resample'] = {}, {}

# Overrides for whether or not certain steps should be skipped (example)
#image2dict['resample']['skip'] = False

# 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

Find and sort all of the input files, ensuring use of absolute paths

sstring = os.path.join(det1_dir, 'jw*rate.fits')  # Use files from the detector1 output folder
rate_files = sorted(glob.glob(sstring))
rate_files = [os.path.abspath(fname) for fname in rate_files]

print(f"Found  {len(rate_files)} science files")
Found  6 science files
# List rate files
rate_files
['/home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRCAM/Imaging/nrc_im_demo_data/Obs001/stage1/jw02739001002_02105_00001_nrca2_rate.fits',
 '/home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRCAM/Imaging/nrc_im_demo_data/Obs001/stage1/jw02739001002_02105_00001_nrca4_rate.fits',
 '/home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRCAM/Imaging/nrc_im_demo_data/Obs001/stage1/jw02739001002_02105_00001_nrcalong_rate.fits',
 '/home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRCAM/Imaging/nrc_im_demo_data/Obs001/stage1/jw02739001002_02105_00002_nrca2_rate.fits',
 '/home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRCAM/Imaging/nrc_im_demo_data/Obs001/stage1/jw02739001002_02105_00002_nrca4_rate.fits',
 '/home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRCAM/Imaging/nrc_im_demo_data/Obs001/stage1/jw02739001002_02105_00002_nrcalong_rate.fits']

Run the Image2 pipeline on all of the rate files, regardless of filter. Note that if you have exposures with multiple integrations and you wish to keep the integrations separate, you should call the pipeline on the *rateints.fits files, rather than the *rate.fits files.

# 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 rate_files:
        cal_result = Image2Pipeline.call(rate, output_dir=image2_dir, steps=image2dict, save_results=True)
else:
    print("Skipping Image2 processing.")
2025-09-13 12:54:01,632 - CRDS - INFO -  Fetching  /home/runner/crds/references/jwst/nircam/jwst_nircam_pars-resamplestep_0001.asdf    1.1 K bytes  (1 / 1 files) (0 / 1.1 K bytes)
2025-09-13 12:54:01,704 - stpipe - INFO - PARS-RESAMPLESTEP parameters found: /home/runner/crds/references/jwst/nircam/jwst_nircam_pars-resamplestep_0001.asdf
2025-09-13 12:54:01,712 - CRDS - INFO -  Fetching  /home/runner/crds/references/jwst/nircam/jwst_nircam_pars-image2pipeline_0003.asdf    1.7 K bytes  (1 / 1 files) (0 / 1.7 K bytes)
2025-09-13 12:54:01,752 - stpipe - INFO - PARS-IMAGE2PIPELINE parameters found: /home/runner/crds/references/jwst/nircam/jwst_nircam_pars-image2pipeline_0003.asdf
2025-09-13 12:54:01,763 - stpipe.Image2Pipeline - INFO - Image2Pipeline instance created.
2025-09-13 12:54:01,764 - stpipe.Image2Pipeline.bkg_subtract - INFO - BackgroundStep instance created.
2025-09-13 12:54:01,765 - stpipe.Image2Pipeline.assign_wcs - INFO - AssignWcsStep instance created.
2025-09-13 12:54:01,766 - stpipe.Image2Pipeline.flat_field - INFO - FlatFieldStep instance created.
2025-09-13 12:54:01,767 - stpipe.Image2Pipeline.photom - INFO - PhotomStep instance created.
2025-09-13 12:54:01,768 - stpipe.Image2Pipeline.resample - INFO - ResampleStep instance created.
2025-09-13 12:54:01,945 - stpipe.Image2Pipeline - INFO - Step Image2Pipeline running with args ('/home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRCAM/Imaging/nrc_im_demo_data/Obs001/stage1/jw02739001002_02105_00001_nrca2_rate.fits',).
2025-09-13 12:54:01,953 - stpipe.Image2Pipeline - INFO - Step Image2Pipeline parameters are:
  pre_hooks: []
  post_hooks: []
  output_file: None
  output_dir: ./nrc_im_demo_data/Obs001/stage2
  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: False
      suffix: None
      search_output_file: True
      input_dir: ''
      pixfrac: 1.0
      kernel: square
      fillval: NAN
      weight_type: exptime
      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 12:54:01,973 - stpipe.Image2Pipeline - INFO - Prefetching reference files for dataset: 'jw02739001002_02105_00001_nrca2_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 12:54:01,976 - CRDS - INFO -  Fetching  /home/runner/crds/references/jwst/nircam/jwst_nircam_area_0263.fits   16.8 M bytes  (1 / 5 files) (0 / 67.2 M bytes)
2025-09-13 12:54:02,328 - CRDS - INFO -  Fetching  /home/runner/crds/references/jwst/nircam/jwst_nircam_distortion_0268.asdf   14.3 K bytes  (2 / 5 files) (16.8 M / 67.2 M bytes)
2025-09-13 12:54:02,398 - CRDS - INFO -  Fetching  /home/runner/crds/references/jwst/nircam/jwst_nircam_filteroffset_0005.asdf   11.4 K bytes  (3 / 5 files) (16.8 M / 67.2 M bytes)
2025-09-13 12:54:02,516 - CRDS - INFO -  Fetching  /home/runner/crds/references/jwst/nircam/jwst_nircam_flat_0654.fits   50.4 M bytes  (4 / 5 files) (16.8 M / 67.2 M bytes)
2025-09-13 12:54:03,352 - CRDS - INFO -  Fetching  /home/runner/crds/references/jwst/nircam/jwst_nircam_photom_0152.fits   23.0 K bytes  (5 / 5 files) (67.2 M / 67.2 M bytes)
2025-09-13 12:54:03,445 - stpipe.Image2Pipeline - INFO - Prefetch for AREA reference file is '/home/runner/crds/references/jwst/nircam/jwst_nircam_area_0263.fits'.
2025-09-13 12:54:03,446 - stpipe.Image2Pipeline - INFO - Prefetch for CAMERA reference file is 'N/A'.
2025-09-13 12:54:03,447 - stpipe.Image2Pipeline - INFO - Prefetch for COLLIMATOR reference file is 'N/A'.
2025-09-13 12:54:03,447 - stpipe.Image2Pipeline - INFO - Prefetch for DFLAT reference file is 'N/A'.
2025-09-13 12:54:03,447 - stpipe.Image2Pipeline - INFO - Prefetch for DISPERSER reference file is 'N/A'.
2025-09-13 12:54:03,448 - stpipe.Image2Pipeline - INFO - Prefetch for DISTORTION reference file is '/home/runner/crds/references/jwst/nircam/jwst_nircam_distortion_0268.asdf'.
2025-09-13 12:54:03,448 - stpipe.Image2Pipeline - INFO - Prefetch for FFLAT reference file is 'N/A'.
2025-09-13 12:54:03,449 - stpipe.Image2Pipeline - INFO - Prefetch for FILTEROFFSET reference file is '/home/runner/crds/references/jwst/nircam/jwst_nircam_filteroffset_0005.asdf'.
2025-09-13 12:54:03,449 - stpipe.Image2Pipeline - INFO - Prefetch for FLAT reference file is '/home/runner/crds/references/jwst/nircam/jwst_nircam_flat_0654.fits'.
2025-09-13 12:54:03,450 - stpipe.Image2Pipeline - INFO - Prefetch for FORE reference file is 'N/A'.
2025-09-13 12:54:03,450 - stpipe.Image2Pipeline - INFO - Prefetch for FPA reference file is 'N/A'.
2025-09-13 12:54:03,450 - stpipe.Image2Pipeline - INFO - Prefetch for IFUFORE reference file is 'N/A'.
2025-09-13 12:54:03,451 - stpipe.Image2Pipeline - INFO - Prefetch for IFUPOST reference file is 'N/A'.
2025-09-13 12:54:03,451 - stpipe.Image2Pipeline - INFO - Prefetch for IFUSLICER reference file is 'N/A'.
2025-09-13 12:54:03,452 - stpipe.Image2Pipeline - INFO - Prefetch for MSA reference file is 'N/A'.
2025-09-13 12:54:03,452 - stpipe.Image2Pipeline - INFO - Prefetch for OTE reference file is 'N/A'.
2025-09-13 12:54:03,453 - stpipe.Image2Pipeline - INFO - Prefetch for PHOTOM reference file is '/home/runner/crds/references/jwst/nircam/jwst_nircam_photom_0152.fits'.
2025-09-13 12:54:03,453 - stpipe.Image2Pipeline - INFO - Prefetch for REGIONS reference file is 'N/A'.
2025-09-13 12:54:03,453 - stpipe.Image2Pipeline - INFO - Prefetch for SFLAT reference file is 'N/A'.
2025-09-13 12:54:03,454 - stpipe.Image2Pipeline - INFO - Prefetch for SPECWCS reference file is 'N/A'.
2025-09-13 12:54:03,454 - stpipe.Image2Pipeline - INFO - Prefetch for WAVELENGTHRANGE reference file is 'N/A'.
2025-09-13 12:54:03,455 - stpipe.Image2Pipeline - INFO - Starting calwebb_image2 ...
2025-09-13 12:54:03,455 - stpipe.Image2Pipeline - INFO - Processing product /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRCAM/Imaging/nrc_im_demo_data/Obs001/stage1/jw02739001002_02105_00001_nrca2
2025-09-13 12:54:03,456 - stpipe.Image2Pipeline - INFO - Working on input /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRCAM/Imaging/nrc_im_demo_data/Obs001/stage1/jw02739001002_02105_00001_nrca2_rate.fits ...
2025-09-13 12:54:03,681 - stpipe.Image2Pipeline.assign_wcs - INFO - Step assign_wcs running with args (<ImageModel(2048, 2048) from ./nrc_im_demo_data/Obs001/stage2/jw02739001002_02105_00001_nrca2_image2pipeline.fits>,).
2025-09-13 12:54:03,896 - stcal.alignment.util - INFO - Update S_REGION to POLYGON ICRS  274.711058212 -13.874495126 274.729104426 -13.875067222 274.729782620 -13.857681871 274.711703355 -13.856918688
2025-09-13 12:54:03,897 - jwst.assign_wcs.assign_wcs - INFO - assign_wcs updated S_REGION to POLYGON ICRS  274.711058212 -13.874495126 274.729104426 -13.875067222 274.729782620 -13.857681871 274.711703355 -13.856918688
2025-09-13 12:54:03,898 - jwst.assign_wcs.assign_wcs - INFO - COMPLETED assign_wcs
2025-09-13 12:54:03,950 - stpipe.Image2Pipeline.assign_wcs - INFO - Step assign_wcs done
2025-09-13 12:54:04,139 - stpipe.Image2Pipeline.flat_field - INFO - Step flat_field running with args (<ImageModel(2048, 2048) from ./nrc_im_demo_data/Obs001/stage2/jw02739001002_02105_00001_nrca2_image2pipeline.fits>,).
2025-09-13 12:54:04,202 - stpipe.Image2Pipeline.flat_field - INFO - Using FLAT reference file: /home/runner/crds/references/jwst/nircam/jwst_nircam_flat_0654.fits
2025-09-13 12:54:04,203 - stpipe.Image2Pipeline.flat_field - INFO - No reference found for type FFLAT
2025-09-13 12:54:04,204 - stpipe.Image2Pipeline.flat_field - INFO - No reference found for type SFLAT
2025-09-13 12:54:04,204 - stpipe.Image2Pipeline.flat_field - INFO - No reference found for type DFLAT
2025-09-13 12:54:04,366 - stpipe.Image2Pipeline.flat_field - INFO - Step flat_field done
2025-09-13 12:54:04,552 - stpipe.Image2Pipeline.photom - INFO - Step photom running with args (<ImageModel(2048, 2048) from ./nrc_im_demo_data/Obs001/stage2/jw02739001002_02105_00001_nrca2_image2pipeline.fits>,).
2025-09-13 12:54:04,568 - stpipe.Image2Pipeline.photom - INFO - Using photom reference file: /home/runner/crds/references/jwst/nircam/jwst_nircam_photom_0152.fits
2025-09-13 12:54:04,569 - stpipe.Image2Pipeline.photom - INFO - Using area reference file: /home/runner/crds/references/jwst/nircam/jwst_nircam_area_0263.fits
2025-09-13 12:54:04,595 - jwst.photom.photom - INFO - Using instrument: NIRCAM
2025-09-13 12:54:04,595 - jwst.photom.photom - INFO -  detector: NRCA2
2025-09-13 12:54:04,596 - jwst.photom.photom - INFO -  exp_type: NRC_IMAGE
2025-09-13 12:54:04,596 - jwst.photom.photom - INFO -  filter: F200W
2025-09-13 12:54:04,597 - jwst.photom.photom - INFO -  pupil: CLEAR
2025-09-13 12:54:04,631 - jwst.photom.photom - INFO - Pixel area map copied to output.
2025-09-13 12:54:04,631 - jwst.photom.photom - INFO - Values for PIXAR_SR and PIXAR_A2 obtained from AREA reference file.
2025-09-13 12:54:04,633 - jwst.photom.photom - INFO - PHOTMJSR value: 2.1
2025-09-13 12:54:04,679 - stpipe.Image2Pipeline.photom - INFO - Step photom done
2025-09-13 12:54:04,863 - stpipe.Image2Pipeline.resample - INFO - Step resample running with args (<ImageModel(2048, 2048) from ./nrc_im_demo_data/Obs001/stage2/jw02739001002_02105_00001_nrca2_image2pipeline.fits>,).
2025-09-13 12:54:04,909 - jwst.resample.resample_utils - INFO - Pixel scale ratio (pscale_out/pscale_in): 1.0
2025-09-13 12:54:04,910 - jwst.resample.resample_utils - INFO - Computed output pixel scale: 0.03077600532160025 arcsec.
2025-09-13 12:54:04,918 - stcal.resample.resample - INFO - Output pixel scale: 0.03077600532160025 arcsec.
2025-09-13 12:54:04,918 - stcal.resample.resample - INFO - Driz parameter kernel: square
2025-09-13 12:54:04,919 - stcal.resample.resample - INFO - Driz parameter pixfrac: 1.0
2025-09-13 12:54:04,919 - stcal.resample.resample - INFO - Driz parameter fillval: NAN
2025-09-13 12:54:04,920 - stcal.resample.resample - INFO - Driz parameter weight_type: exptime
2025-09-13 12:54:04,935 - jwst.resample.resample - INFO - Resampling science and variance data
2025-09-13 12:54:06,898 - stcal.resample.resample - INFO - Resampling science and variance data
2025-09-13 12:54:07,726 - stcal.resample.resample - INFO - Drizzling (2048, 2048) --> (2055, 2057)
2025-09-13 12:54:08,517 - stcal.resample.resample - INFO - Drizzling (2048, 2048) --> (2055, 2057)
2025-09-13 12:54:09,308 - stcal.resample.resample - INFO - Drizzling (2048, 2048) --> (2055, 2057)
2025-09-13 12:54:10,468 - stcal.alignment.util - INFO - Update S_REGION to POLYGON ICRS  274.711009224 -13.874497592 274.729092110 -13.875165678 274.729780210 -13.857593305 274.711698691 -13.856925269
2025-09-13 12:54:10,618 - stpipe.Image2Pipeline.resample - INFO - Saved model in ./nrc_im_demo_data/Obs001/stage2/jw02739001002_02105_00001_nrca2_i2d.fits
2025-09-13 12:54:10,618 - stpipe.Image2Pipeline.resample - INFO - Step resample done
2025-09-13 12:54:10,624 - stpipe.Image2Pipeline - INFO - Finished processing product /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRCAM/Imaging/nrc_im_demo_data/Obs001/stage1/jw02739001002_02105_00001_nrca2
2025-09-13 12:54:10,625 - stpipe.Image2Pipeline - INFO - ... ending calwebb_image2
2025-09-13 12:54:10,626 - jwst.stpipe.core - INFO - Results used CRDS context: jwst_1413.pmap
2025-09-13 12:54:10,793 - stpipe.Image2Pipeline - INFO - Saved model in ./nrc_im_demo_data/Obs001/stage2/jw02739001002_02105_00001_nrca2_cal.fits
2025-09-13 12:54:10,794 - stpipe.Image2Pipeline - INFO - Step Image2Pipeline done
2025-09-13 12:54:10,794 - jwst.stpipe.core - INFO - Results used jwst version: 1.19.1
2025-09-13 12:54:10,820 - stpipe - INFO - PARS-RESAMPLESTEP parameters found: /home/runner/crds/references/jwst/nircam/jwst_nircam_pars-resamplestep_0001.asdf
2025-09-13 12:54:10,828 - stpipe - INFO - PARS-IMAGE2PIPELINE parameters found: /home/runner/crds/references/jwst/nircam/jwst_nircam_pars-image2pipeline_0003.asdf
2025-09-13 12:54:10,838 - stpipe.Image2Pipeline - INFO - Image2Pipeline instance created.
2025-09-13 12:54:10,839 - stpipe.Image2Pipeline.bkg_subtract - INFO - BackgroundStep instance created.
2025-09-13 12:54:10,841 - stpipe.Image2Pipeline.assign_wcs - INFO - AssignWcsStep instance created.
2025-09-13 12:54:10,842 - stpipe.Image2Pipeline.flat_field - INFO - FlatFieldStep instance created.
2025-09-13 12:54:10,843 - stpipe.Image2Pipeline.photom - INFO - PhotomStep instance created.
2025-09-13 12:54:10,844 - stpipe.Image2Pipeline.resample - INFO - ResampleStep instance created.
2025-09-13 12:54:11,034 - stpipe.Image2Pipeline - INFO - Step Image2Pipeline running with args ('/home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRCAM/Imaging/nrc_im_demo_data/Obs001/stage1/jw02739001002_02105_00001_nrca4_rate.fits',).
2025-09-13 12:54:11,041 - stpipe.Image2Pipeline - INFO - Step Image2Pipeline parameters are:
  pre_hooks: []
  post_hooks: []
  output_file: None
  output_dir: ./nrc_im_demo_data/Obs001/stage2
  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: False
      suffix: None
      search_output_file: True
      input_dir: ''
      pixfrac: 1.0
      kernel: square
      fillval: NAN
      weight_type: exptime
      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 12:54:11,062 - stpipe.Image2Pipeline - INFO - Prefetching reference files for dataset: 'jw02739001002_02105_00001_nrca4_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 12:54:11,065 - CRDS - INFO -  Fetching  /home/runner/crds/references/jwst/nircam/jwst_nircam_area_0290.fits   16.8 M bytes  (1 / 4 files) (0 / 67.2 M bytes)
2025-09-13 12:54:11,522 - CRDS - INFO -  Fetching  /home/runner/crds/references/jwst/nircam/jwst_nircam_distortion_0313.asdf   14.3 K bytes  (2 / 4 files) (16.8 M / 67.2 M bytes)
2025-09-13 12:54:11,576 - CRDS - INFO -  Fetching  /home/runner/crds/references/jwst/nircam/jwst_nircam_flat_0653.fits   50.4 M bytes  (3 / 4 files) (16.8 M / 67.2 M bytes)
2025-09-13 12:54:12,413 - CRDS - INFO -  Fetching  /home/runner/crds/references/jwst/nircam/jwst_nircam_photom_0159.fits   23.0 K bytes  (4 / 4 files) (67.2 M / 67.2 M bytes)
2025-09-13 12:54:12,524 - stpipe.Image2Pipeline - INFO - Prefetch for AREA reference file is '/home/runner/crds/references/jwst/nircam/jwst_nircam_area_0290.fits'.
2025-09-13 12:54:12,524 - stpipe.Image2Pipeline - INFO - Prefetch for CAMERA reference file is 'N/A'.
2025-09-13 12:54:12,525 - stpipe.Image2Pipeline - INFO - Prefetch for COLLIMATOR reference file is 'N/A'.
2025-09-13 12:54:12,525 - stpipe.Image2Pipeline - INFO - Prefetch for DFLAT reference file is 'N/A'.
2025-09-13 12:54:12,526 - stpipe.Image2Pipeline - INFO - Prefetch for DISPERSER reference file is 'N/A'.
2025-09-13 12:54:12,526 - stpipe.Image2Pipeline - INFO - Prefetch for DISTORTION reference file is '/home/runner/crds/references/jwst/nircam/jwst_nircam_distortion_0313.asdf'.
2025-09-13 12:54:12,526 - stpipe.Image2Pipeline - INFO - Prefetch for FFLAT reference file is 'N/A'.
2025-09-13 12:54:12,527 - stpipe.Image2Pipeline - INFO - Prefetch for FILTEROFFSET reference file is '/home/runner/crds/references/jwst/nircam/jwst_nircam_filteroffset_0005.asdf'.
2025-09-13 12:54:12,527 - stpipe.Image2Pipeline - INFO - Prefetch for FLAT reference file is '/home/runner/crds/references/jwst/nircam/jwst_nircam_flat_0653.fits'.
2025-09-13 12:54:12,528 - stpipe.Image2Pipeline - INFO - Prefetch for FORE reference file is 'N/A'.
2025-09-13 12:54:12,528 - stpipe.Image2Pipeline - INFO - Prefetch for FPA reference file is 'N/A'.
2025-09-13 12:54:12,529 - stpipe.Image2Pipeline - INFO - Prefetch for IFUFORE reference file is 'N/A'.
2025-09-13 12:54:12,529 - stpipe.Image2Pipeline - INFO - Prefetch for IFUPOST reference file is 'N/A'.
2025-09-13 12:54:12,529 - stpipe.Image2Pipeline - INFO - Prefetch for IFUSLICER reference file is 'N/A'.
2025-09-13 12:54:12,529 - stpipe.Image2Pipeline - INFO - Prefetch for MSA reference file is 'N/A'.
2025-09-13 12:54:12,530 - stpipe.Image2Pipeline - INFO - Prefetch for OTE reference file is 'N/A'.
2025-09-13 12:54:12,530 - stpipe.Image2Pipeline - INFO - Prefetch for PHOTOM reference file is '/home/runner/crds/references/jwst/nircam/jwst_nircam_photom_0159.fits'.
2025-09-13 12:54:12,531 - stpipe.Image2Pipeline - INFO - Prefetch for REGIONS reference file is 'N/A'.
2025-09-13 12:54:12,531 - stpipe.Image2Pipeline - INFO - Prefetch for SFLAT reference file is 'N/A'.
2025-09-13 12:54:12,531 - stpipe.Image2Pipeline - INFO - Prefetch for SPECWCS reference file is 'N/A'.
2025-09-13 12:54:12,532 - stpipe.Image2Pipeline - INFO - Prefetch for WAVELENGTHRANGE reference file is 'N/A'.
2025-09-13 12:54:12,532 - stpipe.Image2Pipeline - INFO - Starting calwebb_image2 ...
2025-09-13 12:54:12,533 - stpipe.Image2Pipeline - INFO - Processing product /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRCAM/Imaging/nrc_im_demo_data/Obs001/stage1/jw02739001002_02105_00001_nrca4
2025-09-13 12:54:12,533 - stpipe.Image2Pipeline - INFO - Working on input /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRCAM/Imaging/nrc_im_demo_data/Obs001/stage1/jw02739001002_02105_00001_nrca4_rate.fits ...
2025-09-13 12:54:12,789 - stpipe.Image2Pipeline.assign_wcs - INFO - Step assign_wcs running with args (<ImageModel(2048, 2048) from ./nrc_im_demo_data/Obs001/stage2/jw02739001002_02105_00001_nrca4_image2pipeline.fits>,).
2025-09-13 12:54:12,929 - stcal.alignment.util - INFO - Update S_REGION to POLYGON ICRS  274.711752617 -13.855757844 274.729841027 -13.856423731 274.730655670 -13.838965521 274.712479943 -13.838105563
2025-09-13 12:54:12,930 - jwst.assign_wcs.assign_wcs - INFO - assign_wcs updated S_REGION to POLYGON ICRS  274.711752617 -13.855757844 274.729841027 -13.856423731 274.730655670 -13.838965521 274.712479943 -13.838105563
2025-09-13 12:54:12,931 - jwst.assign_wcs.assign_wcs - INFO - COMPLETED assign_wcs
2025-09-13 12:54:12,959 - py.warnings - WARNING - /usr/share/miniconda/lib/python3.13/site-packages/gwcs/wcs/_wcs.py:1761: UserWarning: Double sampling check FAILED: Sampling may be too coarse for the distortion model being fitted.
  fit_poly_x, fit_poly_y, max_resid = fit_2D_poly(
2025-09-13 12:54:12,980 - stpipe.Image2Pipeline.assign_wcs - INFO - Step assign_wcs done
2025-09-13 12:54:13,174 - stpipe.Image2Pipeline.flat_field - INFO - Step flat_field running with args (<ImageModel(2048, 2048) from ./nrc_im_demo_data/Obs001/stage2/jw02739001002_02105_00001_nrca4_image2pipeline.fits>,).
2025-09-13 12:54:13,230 - stpipe.Image2Pipeline.flat_field - INFO - Using FLAT reference file: /home/runner/crds/references/jwst/nircam/jwst_nircam_flat_0653.fits
2025-09-13 12:54:13,231 - stpipe.Image2Pipeline.flat_field - INFO - No reference found for type FFLAT
2025-09-13 12:54:13,231 - stpipe.Image2Pipeline.flat_field - INFO - No reference found for type SFLAT
2025-09-13 12:54:13,232 - stpipe.Image2Pipeline.flat_field - INFO - No reference found for type DFLAT
2025-09-13 12:54:13,392 - stpipe.Image2Pipeline.flat_field - INFO - Step flat_field done
2025-09-13 12:54:13,580 - stpipe.Image2Pipeline.photom - INFO - Step photom running with args (<ImageModel(2048, 2048) from ./nrc_im_demo_data/Obs001/stage2/jw02739001002_02105_00001_nrca4_image2pipeline.fits>,).
2025-09-13 12:54:13,592 - stpipe.Image2Pipeline.photom - INFO - Using photom reference file: /home/runner/crds/references/jwst/nircam/jwst_nircam_photom_0159.fits
2025-09-13 12:54:13,592 - stpipe.Image2Pipeline.photom - INFO - Using area reference file: /home/runner/crds/references/jwst/nircam/jwst_nircam_area_0290.fits
2025-09-13 12:54:13,619 - jwst.photom.photom - INFO - Using instrument: NIRCAM
2025-09-13 12:54:13,619 - jwst.photom.photom - INFO -  detector: NRCA4
2025-09-13 12:54:13,620 - jwst.photom.photom - INFO -  exp_type: NRC_IMAGE
2025-09-13 12:54:13,620 - jwst.photom.photom - INFO -  filter: F200W
2025-09-13 12:54:13,621 - jwst.photom.photom - INFO -  pupil: CLEAR
2025-09-13 12:54:13,651 - jwst.photom.photom - INFO - Pixel area map copied to output.
2025-09-13 12:54:13,652 - jwst.photom.photom - INFO - Values for PIXAR_SR and PIXAR_A2 obtained from AREA reference file.
2025-09-13 12:54:13,653 - jwst.photom.photom - INFO - PHOTMJSR value: 1.829
2025-09-13 12:54:13,700 - stpipe.Image2Pipeline.photom - INFO - Step photom done
2025-09-13 12:54:13,885 - stpipe.Image2Pipeline.resample - INFO - Step resample running with args (<ImageModel(2048, 2048) from ./nrc_im_demo_data/Obs001/stage2/jw02739001002_02105_00001_nrca4_image2pipeline.fits>,).
2025-09-13 12:54:13,931 - jwst.resample.resample_utils - INFO - Pixel scale ratio (pscale_out/pscale_in): 1.0
2025-09-13 12:54:13,931 - jwst.resample.resample_utils - INFO - Computed output pixel scale: 0.0309078884492061 arcsec.
2025-09-13 12:54:13,938 - stcal.resample.resample - INFO - Output pixel scale: 0.0309078884492061 arcsec.
2025-09-13 12:54:13,939 - stcal.resample.resample - INFO - Driz parameter kernel: square
2025-09-13 12:54:13,939 - stcal.resample.resample - INFO - Driz parameter pixfrac: 1.0
2025-09-13 12:54:13,940 - stcal.resample.resample - INFO - Driz parameter fillval: NAN
2025-09-13 12:54:13,940 - stcal.resample.resample - INFO - Driz parameter weight_type: exptime
2025-09-13 12:54:13,956 - jwst.resample.resample - INFO - Resampling science and variance data
2025-09-13 12:54:15,930 - stcal.resample.resample - INFO - Resampling science and variance data
2025-09-13 12:54:16,762 - stcal.resample.resample - INFO - Drizzling (2048, 2048) --> (2058, 2058)
2025-09-13 12:54:17,556 - stcal.resample.resample - INFO - Drizzling (2048, 2048) --> (2058, 2058)
2025-09-13 12:54:18,345 - stcal.resample.resample - INFO - Drizzling (2048, 2048) --> (2058, 2058)
2025-09-13 12:54:19,500 - stcal.alignment.util - INFO - Update S_REGION to POLYGON ICRS  274.711685260 -13.855759298 274.729866710 -13.856525888 274.730655528 -13.838873486 274.712475455 -13.838106955
2025-09-13 12:54:19,647 - stpipe.Image2Pipeline.resample - INFO - Saved model in ./nrc_im_demo_data/Obs001/stage2/jw02739001002_02105_00001_nrca4_i2d.fits
2025-09-13 12:54:19,647 - stpipe.Image2Pipeline.resample - INFO - Step resample done
2025-09-13 12:54:19,653 - stpipe.Image2Pipeline - INFO - Finished processing product /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRCAM/Imaging/nrc_im_demo_data/Obs001/stage1/jw02739001002_02105_00001_nrca4
2025-09-13 12:54:19,653 - stpipe.Image2Pipeline - INFO - ... ending calwebb_image2
2025-09-13 12:54:19,654 - jwst.stpipe.core - INFO - Results used CRDS context: jwst_1413.pmap
2025-09-13 12:54:19,823 - stpipe.Image2Pipeline - INFO - Saved model in ./nrc_im_demo_data/Obs001/stage2/jw02739001002_02105_00001_nrca4_cal.fits
2025-09-13 12:54:19,824 - stpipe.Image2Pipeline - INFO - Step Image2Pipeline done
2025-09-13 12:54:19,824 - jwst.stpipe.core - INFO - Results used jwst version: 1.19.1
2025-09-13 12:54:19,850 - stpipe - INFO - PARS-RESAMPLESTEP parameters found: /home/runner/crds/references/jwst/nircam/jwst_nircam_pars-resamplestep_0001.asdf
2025-09-13 12:54:19,858 - stpipe - INFO - PARS-IMAGE2PIPELINE parameters found: /home/runner/crds/references/jwst/nircam/jwst_nircam_pars-image2pipeline_0003.asdf
2025-09-13 12:54:19,868 - stpipe.Image2Pipeline - INFO - Image2Pipeline instance created.
2025-09-13 12:54:19,869 - stpipe.Image2Pipeline.bkg_subtract - INFO - BackgroundStep instance created.
2025-09-13 12:54:19,871 - stpipe.Image2Pipeline.assign_wcs - INFO - AssignWcsStep instance created.
2025-09-13 12:54:19,871 - stpipe.Image2Pipeline.flat_field - INFO - FlatFieldStep instance created.
2025-09-13 12:54:19,872 - stpipe.Image2Pipeline.photom - INFO - PhotomStep instance created.
2025-09-13 12:54:19,873 - stpipe.Image2Pipeline.resample - INFO - ResampleStep instance created.
2025-09-13 12:54:20,059 - stpipe.Image2Pipeline - INFO - Step Image2Pipeline running with args ('/home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRCAM/Imaging/nrc_im_demo_data/Obs001/stage1/jw02739001002_02105_00001_nrcalong_rate.fits',).
2025-09-13 12:54:20,066 - stpipe.Image2Pipeline - INFO - Step Image2Pipeline parameters are:
  pre_hooks: []
  post_hooks: []
  output_file: None
  output_dir: ./nrc_im_demo_data/Obs001/stage2
  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: False
      suffix: None
      search_output_file: True
      input_dir: ''
      pixfrac: 1.0
      kernel: square
      fillval: NAN
      weight_type: exptime
      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 12:54:20,086 - stpipe.Image2Pipeline - INFO - Prefetching reference files for dataset: 'jw02739001002_02105_00001_nrcalong_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 12:54:20,089 - CRDS - INFO -  Fetching  /home/runner/crds/references/jwst/nircam/jwst_nircam_area_0261.fits   16.8 M bytes  (1 / 5 files) (0 / 67.2 M bytes)
2025-09-13 12:54:20,391 - CRDS - INFO -  Fetching  /home/runner/crds/references/jwst/nircam/jwst_nircam_distortion_0277.asdf   12.7 K bytes  (2 / 5 files) (16.8 M / 67.2 M bytes)
2025-09-13 12:54:20,425 - CRDS - INFO -  Fetching  /home/runner/crds/references/jwst/nircam/jwst_nircam_filteroffset_0007.asdf   11.4 K bytes  (3 / 5 files) (16.8 M / 67.2 M bytes)
2025-09-13 12:54:20,465 - CRDS - INFO -  Fetching  /home/runner/crds/references/jwst/nircam/jwst_nircam_flat_0761.fits   50.4 M bytes  (4 / 5 files) (16.8 M / 67.2 M bytes)
2025-09-13 12:54:21,486 - CRDS - INFO -  Fetching  /home/runner/crds/references/jwst/nircam/jwst_nircam_photom_0157.fits   23.0 K bytes  (5 / 5 files) (67.2 M / 67.2 M bytes)
2025-09-13 12:54:21,537 - stpipe.Image2Pipeline - INFO - Prefetch for AREA reference file is '/home/runner/crds/references/jwst/nircam/jwst_nircam_area_0261.fits'.
2025-09-13 12:54:21,537 - stpipe.Image2Pipeline - INFO - Prefetch for CAMERA reference file is 'N/A'.
2025-09-13 12:54:21,538 - stpipe.Image2Pipeline - INFO - Prefetch for COLLIMATOR reference file is 'N/A'.
2025-09-13 12:54:21,538 - stpipe.Image2Pipeline - INFO - Prefetch for DFLAT reference file is 'N/A'.
2025-09-13 12:54:21,538 - stpipe.Image2Pipeline - INFO - Prefetch for DISPERSER reference file is 'N/A'.
2025-09-13 12:54:21,539 - stpipe.Image2Pipeline - INFO - Prefetch for DISTORTION reference file is '/home/runner/crds/references/jwst/nircam/jwst_nircam_distortion_0277.asdf'.
2025-09-13 12:54:21,539 - stpipe.Image2Pipeline - INFO - Prefetch for FFLAT reference file is 'N/A'.
2025-09-13 12:54:21,540 - stpipe.Image2Pipeline - INFO - Prefetch for FILTEROFFSET reference file is '/home/runner/crds/references/jwst/nircam/jwst_nircam_filteroffset_0007.asdf'.
2025-09-13 12:54:21,540 - stpipe.Image2Pipeline - INFO - Prefetch for FLAT reference file is '/home/runner/crds/references/jwst/nircam/jwst_nircam_flat_0761.fits'.
2025-09-13 12:54:21,541 - stpipe.Image2Pipeline - INFO - Prefetch for FORE reference file is 'N/A'.
2025-09-13 12:54:21,541 - stpipe.Image2Pipeline - INFO - Prefetch for FPA reference file is 'N/A'.
2025-09-13 12:54:21,541 - stpipe.Image2Pipeline - INFO - Prefetch for IFUFORE reference file is 'N/A'.
2025-09-13 12:54:21,542 - stpipe.Image2Pipeline - INFO - Prefetch for IFUPOST reference file is 'N/A'.
2025-09-13 12:54:21,542 - stpipe.Image2Pipeline - INFO - Prefetch for IFUSLICER reference file is 'N/A'.
2025-09-13 12:54:21,542 - stpipe.Image2Pipeline - INFO - Prefetch for MSA reference file is 'N/A'.
2025-09-13 12:54:21,543 - stpipe.Image2Pipeline - INFO - Prefetch for OTE reference file is 'N/A'.
2025-09-13 12:54:21,543 - stpipe.Image2Pipeline - INFO - Prefetch for PHOTOM reference file is '/home/runner/crds/references/jwst/nircam/jwst_nircam_photom_0157.fits'.
2025-09-13 12:54:21,543 - stpipe.Image2Pipeline - INFO - Prefetch for REGIONS reference file is 'N/A'.
2025-09-13 12:54:21,544 - stpipe.Image2Pipeline - INFO - Prefetch for SFLAT reference file is 'N/A'.
2025-09-13 12:54:21,544 - stpipe.Image2Pipeline - INFO - Prefetch for SPECWCS reference file is 'N/A'.
2025-09-13 12:54:21,544 - stpipe.Image2Pipeline - INFO - Prefetch for WAVELENGTHRANGE reference file is 'N/A'.
2025-09-13 12:54:21,545 - stpipe.Image2Pipeline - INFO - Starting calwebb_image2 ...
2025-09-13 12:54:21,545 - stpipe.Image2Pipeline - INFO - Processing product /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRCAM/Imaging/nrc_im_demo_data/Obs001/stage1/jw02739001002_02105_00001_nrcalong
2025-09-13 12:54:21,546 - stpipe.Image2Pipeline - INFO - Working on input /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRCAM/Imaging/nrc_im_demo_data/Obs001/stage1/jw02739001002_02105_00001_nrcalong_rate.fits ...
2025-09-13 12:54:21,820 - stpipe.Image2Pipeline.assign_wcs - INFO - Step assign_wcs running with args (<ImageModel(2048, 2048) from ./nrc_im_demo_data/Obs001/stage2/jw02739001002_02105_00001_nrcalong_image2pipeline.fits>,).
2025-09-13 12:54:21,960 - stcal.alignment.util - INFO - Update S_REGION to POLYGON ICRS  274.691991546 -13.873613048 274.728925862 -13.874644088 274.730478712 -13.839274842 274.693313216 -13.837379687
2025-09-13 12:54:21,961 - jwst.assign_wcs.assign_wcs - INFO - assign_wcs updated S_REGION to POLYGON ICRS  274.691991546 -13.873613048 274.728925862 -13.874644088 274.730478712 -13.839274842 274.693313216 -13.837379687
2025-09-13 12:54:21,962 - jwst.assign_wcs.assign_wcs - INFO - COMPLETED assign_wcs
2025-09-13 12:54:22,017 - stpipe.Image2Pipeline.assign_wcs - INFO - Step assign_wcs done
2025-09-13 12:54:22,213 - stpipe.Image2Pipeline.flat_field - INFO - Step flat_field running with args (<ImageModel(2048, 2048) from ./nrc_im_demo_data/Obs001/stage2/jw02739001002_02105_00001_nrcalong_image2pipeline.fits>,).
2025-09-13 12:54:22,268 - stpipe.Image2Pipeline.flat_field - INFO - Using FLAT reference file: /home/runner/crds/references/jwst/nircam/jwst_nircam_flat_0761.fits
2025-09-13 12:54:22,269 - stpipe.Image2Pipeline.flat_field - INFO - No reference found for type FFLAT
2025-09-13 12:54:22,269 - stpipe.Image2Pipeline.flat_field - INFO - No reference found for type SFLAT
2025-09-13 12:54:22,269 - stpipe.Image2Pipeline.flat_field - INFO - No reference found for type DFLAT
2025-09-13 12:54:22,431 - stpipe.Image2Pipeline.flat_field - INFO - Step flat_field done
2025-09-13 12:54:22,614 - stpipe.Image2Pipeline.photom - INFO - Step photom running with args (<ImageModel(2048, 2048) from ./nrc_im_demo_data/Obs001/stage2/jw02739001002_02105_00001_nrcalong_image2pipeline.fits>,).
2025-09-13 12:54:22,627 - stpipe.Image2Pipeline.photom - INFO - Using photom reference file: /home/runner/crds/references/jwst/nircam/jwst_nircam_photom_0157.fits
2025-09-13 12:54:22,627 - stpipe.Image2Pipeline.photom - INFO - Using area reference file: /home/runner/crds/references/jwst/nircam/jwst_nircam_area_0261.fits
2025-09-13 12:54:22,653 - jwst.photom.photom - INFO - Using instrument: NIRCAM
2025-09-13 12:54:22,653 - jwst.photom.photom - INFO -  detector: NRCALONG
2025-09-13 12:54:22,654 - jwst.photom.photom - INFO -  exp_type: NRC_IMAGE
2025-09-13 12:54:22,654 - jwst.photom.photom - INFO -  filter: F444W
2025-09-13 12:54:22,655 - jwst.photom.photom - INFO -  pupil: CLEAR
2025-09-13 12:54:22,684 - jwst.photom.photom - INFO - Pixel area map copied to output.
2025-09-13 12:54:22,685 - jwst.photom.photom - INFO - Values for PIXAR_SR and PIXAR_A2 obtained from AREA reference file.
2025-09-13 12:54:22,686 - jwst.photom.photom - INFO - PHOTMJSR value: 0.402
2025-09-13 12:54:22,745 - stpipe.Image2Pipeline.photom - INFO - Step photom done
2025-09-13 12:54:22,933 - stpipe.Image2Pipeline.resample - INFO - Step resample running with args (<ImageModel(2048, 2048) from ./nrc_im_demo_data/Obs001/stage2/jw02739001002_02105_00001_nrcalong_image2pipeline.fits>,).
2025-09-13 12:54:22,990 - jwst.resample.resample_utils - INFO - Pixel scale ratio (pscale_out/pscale_in): 1.0
2025-09-13 12:54:22,991 - jwst.resample.resample_utils - INFO - Computed output pixel scale: 0.06290626049410467 arcsec.
2025-09-13 12:54:22,998 - stcal.resample.resample - INFO - Output pixel scale: 0.06290626049410467 arcsec.
2025-09-13 12:54:22,998 - stcal.resample.resample - INFO - Driz parameter kernel: square
2025-09-13 12:54:22,998 - stcal.resample.resample - INFO - Driz parameter pixfrac: 1.0
2025-09-13 12:54:22,999 - stcal.resample.resample - INFO - Driz parameter fillval: NAN
2025-09-13 12:54:22,999 - stcal.resample.resample - INFO - Driz parameter weight_type: exptime
2025-09-13 12:54:23,015 - jwst.resample.resample - INFO - Resampling science and variance data
2025-09-13 12:54:24,976 - stcal.resample.resample - INFO - Resampling science and variance data
2025-09-13 12:54:25,826 - stcal.resample.resample - INFO - Drizzling (2048, 2048) --> (2068, 2075)
2025-09-13 12:54:26,624 - stcal.resample.resample - INFO - Drizzling (2048, 2048) --> (2068, 2075)
2025-09-13 12:54:27,427 - stcal.resample.resample - INFO - Drizzling (2048, 2048) --> (2068, 2075)
2025-09-13 12:54:28,590 - stcal.alignment.util - INFO - Update S_REGION to POLYGON ICRS  274.691785814 -13.873613665 274.728977301 -13.875079993 274.730489677 -13.838851271 274.693303981 -13.837385172
2025-09-13 12:54:28,740 - stpipe.Image2Pipeline.resample - INFO - Saved model in ./nrc_im_demo_data/Obs001/stage2/jw02739001002_02105_00001_nrcalong_i2d.fits
2025-09-13 12:54:28,741 - stpipe.Image2Pipeline.resample - INFO - Step resample done
2025-09-13 12:54:28,746 - stpipe.Image2Pipeline - INFO - Finished processing product /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRCAM/Imaging/nrc_im_demo_data/Obs001/stage1/jw02739001002_02105_00001_nrcalong
2025-09-13 12:54:28,747 - stpipe.Image2Pipeline - INFO - ... ending calwebb_image2
2025-09-13 12:54:28,748 - jwst.stpipe.core - INFO - Results used CRDS context: jwst_1413.pmap
2025-09-13 12:54:28,917 - stpipe.Image2Pipeline - INFO - Saved model in ./nrc_im_demo_data/Obs001/stage2/jw02739001002_02105_00001_nrcalong_cal.fits
2025-09-13 12:54:28,918 - stpipe.Image2Pipeline - INFO - Step Image2Pipeline done
2025-09-13 12:54:28,918 - jwst.stpipe.core - INFO - Results used jwst version: 1.19.1
2025-09-13 12:54:28,943 - stpipe - INFO - PARS-RESAMPLESTEP parameters found: /home/runner/crds/references/jwst/nircam/jwst_nircam_pars-resamplestep_0001.asdf
2025-09-13 12:54:28,951 - stpipe - INFO - PARS-IMAGE2PIPELINE parameters found: /home/runner/crds/references/jwst/nircam/jwst_nircam_pars-image2pipeline_0003.asdf
2025-09-13 12:54:28,961 - stpipe.Image2Pipeline - INFO - Image2Pipeline instance created.
2025-09-13 12:54:28,962 - stpipe.Image2Pipeline.bkg_subtract - INFO - BackgroundStep instance created.
2025-09-13 12:54:28,963 - stpipe.Image2Pipeline.assign_wcs - INFO - AssignWcsStep instance created.
2025-09-13 12:54:28,964 - stpipe.Image2Pipeline.flat_field - INFO - FlatFieldStep instance created.
2025-09-13 12:54:28,965 - stpipe.Image2Pipeline.photom - INFO - PhotomStep instance created.
2025-09-13 12:54:28,967 - stpipe.Image2Pipeline.resample - INFO - ResampleStep instance created.
2025-09-13 12:54:29,156 - stpipe.Image2Pipeline - INFO - Step Image2Pipeline running with args ('/home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRCAM/Imaging/nrc_im_demo_data/Obs001/stage1/jw02739001002_02105_00002_nrca2_rate.fits',).
2025-09-13 12:54:29,164 - stpipe.Image2Pipeline - INFO - Step Image2Pipeline parameters are:
  pre_hooks: []
  post_hooks: []
  output_file: None
  output_dir: ./nrc_im_demo_data/Obs001/stage2
  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: False
      suffix: None
      search_output_file: True
      input_dir: ''
      pixfrac: 1.0
      kernel: square
      fillval: NAN
      weight_type: exptime
      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 12:54:29,183 - stpipe.Image2Pipeline - INFO - Prefetching reference files for dataset: 'jw02739001002_02105_00002_nrca2_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 12:54:29,186 - stpipe.Image2Pipeline - INFO - Prefetch for AREA reference file is '/home/runner/crds/references/jwst/nircam/jwst_nircam_area_0263.fits'.
2025-09-13 12:54:29,187 - stpipe.Image2Pipeline - INFO - Prefetch for CAMERA reference file is 'N/A'.
2025-09-13 12:54:29,187 - stpipe.Image2Pipeline - INFO - Prefetch for COLLIMATOR reference file is 'N/A'.
2025-09-13 12:54:29,187 - stpipe.Image2Pipeline - INFO - Prefetch for DFLAT reference file is 'N/A'.
2025-09-13 12:54:29,188 - stpipe.Image2Pipeline - INFO - Prefetch for DISPERSER reference file is 'N/A'.
2025-09-13 12:54:29,188 - stpipe.Image2Pipeline - INFO - Prefetch for DISTORTION reference file is '/home/runner/crds/references/jwst/nircam/jwst_nircam_distortion_0268.asdf'.
2025-09-13 12:54:29,190 - stpipe.Image2Pipeline - INFO - Prefetch for FFLAT reference file is 'N/A'.
2025-09-13 12:54:29,190 - stpipe.Image2Pipeline - INFO - Prefetch for FILTEROFFSET reference file is '/home/runner/crds/references/jwst/nircam/jwst_nircam_filteroffset_0005.asdf'.
2025-09-13 12:54:29,190 - stpipe.Image2Pipeline - INFO - Prefetch for FLAT reference file is '/home/runner/crds/references/jwst/nircam/jwst_nircam_flat_0654.fits'.
2025-09-13 12:54:29,191 - stpipe.Image2Pipeline - INFO - Prefetch for FORE reference file is 'N/A'.
2025-09-13 12:54:29,192 - stpipe.Image2Pipeline - INFO - Prefetch for FPA reference file is 'N/A'.
2025-09-13 12:54:29,192 - stpipe.Image2Pipeline - INFO - Prefetch for IFUFORE reference file is 'N/A'.
2025-09-13 12:54:29,192 - stpipe.Image2Pipeline - INFO - Prefetch for IFUPOST reference file is 'N/A'.
2025-09-13 12:54:29,193 - stpipe.Image2Pipeline - INFO - Prefetch for IFUSLICER reference file is 'N/A'.
2025-09-13 12:54:29,193 - stpipe.Image2Pipeline - INFO - Prefetch for MSA reference file is 'N/A'.
2025-09-13 12:54:29,193 - stpipe.Image2Pipeline - INFO - Prefetch for OTE reference file is 'N/A'.
2025-09-13 12:54:29,194 - stpipe.Image2Pipeline - INFO - Prefetch for PHOTOM reference file is '/home/runner/crds/references/jwst/nircam/jwst_nircam_photom_0152.fits'.
2025-09-13 12:54:29,195 - stpipe.Image2Pipeline - INFO - Prefetch for REGIONS reference file is 'N/A'.
2025-09-13 12:54:29,195 - stpipe.Image2Pipeline - INFO - Prefetch for SFLAT reference file is 'N/A'.
2025-09-13 12:54:29,195 - stpipe.Image2Pipeline - INFO - Prefetch for SPECWCS reference file is 'N/A'.
2025-09-13 12:54:29,196 - stpipe.Image2Pipeline - INFO - Prefetch for WAVELENGTHRANGE reference file is 'N/A'.
2025-09-13 12:54:29,196 - stpipe.Image2Pipeline - INFO - Starting calwebb_image2 ...
2025-09-13 12:54:29,197 - stpipe.Image2Pipeline - INFO - Processing product /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRCAM/Imaging/nrc_im_demo_data/Obs001/stage1/jw02739001002_02105_00002_nrca2
2025-09-13 12:54:29,197 - stpipe.Image2Pipeline - INFO - Working on input /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRCAM/Imaging/nrc_im_demo_data/Obs001/stage1/jw02739001002_02105_00002_nrca2_rate.fits ...
2025-09-13 12:54:29,456 - stpipe.Image2Pipeline.assign_wcs - INFO - Step assign_wcs running with args (<ImageModel(2048, 2048) from ./nrc_im_demo_data/Obs001/stage2/jw02739001002_02105_00002_nrca2_image2pipeline.fits>,).
2025-09-13 12:54:29,597 - stcal.alignment.util - INFO - Update S_REGION to POLYGON ICRS  274.714143522 -13.874670709 274.732189757 -13.875242614 274.732867755 -13.857857255 274.714788468 -13.857094264
2025-09-13 12:54:29,598 - jwst.assign_wcs.assign_wcs - INFO - assign_wcs updated S_REGION to POLYGON ICRS  274.714143522 -13.874670709 274.732189757 -13.875242614 274.732867755 -13.857857255 274.714788468 -13.857094264
2025-09-13 12:54:29,599 - jwst.assign_wcs.assign_wcs - INFO - COMPLETED assign_wcs
2025-09-13 12:54:29,642 - stpipe.Image2Pipeline.assign_wcs - INFO - Step assign_wcs done
2025-09-13 12:54:29,830 - stpipe.Image2Pipeline.flat_field - INFO - Step flat_field running with args (<ImageModel(2048, 2048) from ./nrc_im_demo_data/Obs001/stage2/jw02739001002_02105_00002_nrca2_image2pipeline.fits>,).
2025-09-13 12:54:29,886 - stpipe.Image2Pipeline.flat_field - INFO - Using FLAT reference file: /home/runner/crds/references/jwst/nircam/jwst_nircam_flat_0654.fits
2025-09-13 12:54:29,887 - stpipe.Image2Pipeline.flat_field - INFO - No reference found for type FFLAT
2025-09-13 12:54:29,887 - stpipe.Image2Pipeline.flat_field - INFO - No reference found for type SFLAT
2025-09-13 12:54:29,888 - stpipe.Image2Pipeline.flat_field - INFO - No reference found for type DFLAT
2025-09-13 12:54:30,051 - stpipe.Image2Pipeline.flat_field - INFO - Step flat_field done
2025-09-13 12:54:30,238 - stpipe.Image2Pipeline.photom - INFO - Step photom running with args (<ImageModel(2048, 2048) from ./nrc_im_demo_data/Obs001/stage2/jw02739001002_02105_00002_nrca2_image2pipeline.fits>,).
2025-09-13 12:54:30,250 - stpipe.Image2Pipeline.photom - INFO - Using photom reference file: /home/runner/crds/references/jwst/nircam/jwst_nircam_photom_0152.fits
2025-09-13 12:54:30,250 - stpipe.Image2Pipeline.photom - INFO - Using area reference file: /home/runner/crds/references/jwst/nircam/jwst_nircam_area_0263.fits
2025-09-13 12:54:30,277 - jwst.photom.photom - INFO - Using instrument: NIRCAM
2025-09-13 12:54:30,277 - jwst.photom.photom - INFO -  detector: NRCA2
2025-09-13 12:54:30,278 - jwst.photom.photom - INFO -  exp_type: NRC_IMAGE
2025-09-13 12:54:30,278 - jwst.photom.photom - INFO -  filter: F200W
2025-09-13 12:54:30,279 - jwst.photom.photom - INFO -  pupil: CLEAR
2025-09-13 12:54:30,309 - jwst.photom.photom - INFO - Pixel area map copied to output.
2025-09-13 12:54:30,310 - jwst.photom.photom - INFO - Values for PIXAR_SR and PIXAR_A2 obtained from AREA reference file.
2025-09-13 12:54:30,311 - jwst.photom.photom - INFO - PHOTMJSR value: 2.1
2025-09-13 12:54:30,359 - stpipe.Image2Pipeline.photom - INFO - Step photom done
2025-09-13 12:54:30,546 - stpipe.Image2Pipeline.resample - INFO - Step resample running with args (<ImageModel(2048, 2048) from ./nrc_im_demo_data/Obs001/stage2/jw02739001002_02105_00002_nrca2_image2pipeline.fits>,).
2025-09-13 12:54:30,593 - jwst.resample.resample_utils - INFO - Pixel scale ratio (pscale_out/pscale_in): 1.0
2025-09-13 12:54:30,593 - jwst.resample.resample_utils - INFO - Computed output pixel scale: 0.03077600525656764 arcsec.
2025-09-13 12:54:30,601 - stcal.resample.resample - INFO - Output pixel scale: 0.03077600525656764 arcsec.
2025-09-13 12:54:30,601 - stcal.resample.resample - INFO - Driz parameter kernel: square
2025-09-13 12:54:30,601 - stcal.resample.resample - INFO - Driz parameter pixfrac: 1.0
2025-09-13 12:54:30,602 - stcal.resample.resample - INFO - Driz parameter fillval: NAN
2025-09-13 12:54:30,602 - stcal.resample.resample - INFO - Driz parameter weight_type: exptime
2025-09-13 12:54:30,618 - jwst.resample.resample - INFO - Resampling science and variance data
2025-09-13 12:54:32,591 - stcal.resample.resample - INFO - Resampling science and variance data
2025-09-13 12:54:33,420 - stcal.resample.resample - INFO - Drizzling (2048, 2048) --> (2055, 2057)
2025-09-13 12:54:34,212 - stcal.resample.resample - INFO - Drizzling (2048, 2048) --> (2055, 2057)
2025-09-13 12:54:35,000 - stcal.resample.resample - INFO - Drizzling (2048, 2048) --> (2055, 2057)
2025-09-13 12:54:36,142 - stcal.alignment.util - INFO - Update S_REGION to POLYGON ICRS  274.714094534 -13.874673175 274.732177441 -13.875341070 274.732865344 -13.857768690 274.714783804 -13.857100845
2025-09-13 12:54:36,292 - stpipe.Image2Pipeline.resample - INFO - Saved model in ./nrc_im_demo_data/Obs001/stage2/jw02739001002_02105_00002_nrca2_i2d.fits
2025-09-13 12:54:36,293 - stpipe.Image2Pipeline.resample - INFO - Step resample done
2025-09-13 12:54:36,298 - stpipe.Image2Pipeline - INFO - Finished processing product /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRCAM/Imaging/nrc_im_demo_data/Obs001/stage1/jw02739001002_02105_00002_nrca2
2025-09-13 12:54:36,299 - stpipe.Image2Pipeline - INFO - ... ending calwebb_image2
2025-09-13 12:54:36,299 - jwst.stpipe.core - INFO - Results used CRDS context: jwst_1413.pmap
2025-09-13 12:54:36,468 - stpipe.Image2Pipeline - INFO - Saved model in ./nrc_im_demo_data/Obs001/stage2/jw02739001002_02105_00002_nrca2_cal.fits
2025-09-13 12:54:36,469 - stpipe.Image2Pipeline - INFO - Step Image2Pipeline done
2025-09-13 12:54:36,469 - jwst.stpipe.core - INFO - Results used jwst version: 1.19.1
2025-09-13 12:54:36,492 - stpipe - INFO - PARS-RESAMPLESTEP parameters found: /home/runner/crds/references/jwst/nircam/jwst_nircam_pars-resamplestep_0001.asdf
2025-09-13 12:54:36,500 - stpipe - INFO - PARS-IMAGE2PIPELINE parameters found: /home/runner/crds/references/jwst/nircam/jwst_nircam_pars-image2pipeline_0003.asdf
2025-09-13 12:54:36,510 - stpipe.Image2Pipeline - INFO - Image2Pipeline instance created.
2025-09-13 12:54:36,511 - stpipe.Image2Pipeline.bkg_subtract - INFO - BackgroundStep instance created.
2025-09-13 12:54:36,512 - stpipe.Image2Pipeline.assign_wcs - INFO - AssignWcsStep instance created.
2025-09-13 12:54:36,513 - stpipe.Image2Pipeline.flat_field - INFO - FlatFieldStep instance created.
2025-09-13 12:54:36,514 - stpipe.Image2Pipeline.photom - INFO - PhotomStep instance created.
2025-09-13 12:54:36,515 - stpipe.Image2Pipeline.resample - INFO - ResampleStep instance created.
2025-09-13 12:54:36,699 - stpipe.Image2Pipeline - INFO - Step Image2Pipeline running with args ('/home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRCAM/Imaging/nrc_im_demo_data/Obs001/stage1/jw02739001002_02105_00002_nrca4_rate.fits',).
2025-09-13 12:54:36,707 - stpipe.Image2Pipeline - INFO - Step Image2Pipeline parameters are:
  pre_hooks: []
  post_hooks: []
  output_file: None
  output_dir: ./nrc_im_demo_data/Obs001/stage2
  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: False
      suffix: None
      search_output_file: True
      input_dir: ''
      pixfrac: 1.0
      kernel: square
      fillval: NAN
      weight_type: exptime
      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 12:54:36,727 - stpipe.Image2Pipeline - INFO - Prefetching reference files for dataset: 'jw02739001002_02105_00002_nrca4_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 12:54:36,730 - stpipe.Image2Pipeline - INFO - Prefetch for AREA reference file is '/home/runner/crds/references/jwst/nircam/jwst_nircam_area_0290.fits'.
2025-09-13 12:54:36,731 - stpipe.Image2Pipeline - INFO - Prefetch for CAMERA reference file is 'N/A'.
2025-09-13 12:54:36,731 - stpipe.Image2Pipeline - INFO - Prefetch for COLLIMATOR reference file is 'N/A'.
2025-09-13 12:54:36,731 - stpipe.Image2Pipeline - INFO - Prefetch for DFLAT reference file is 'N/A'.
2025-09-13 12:54:36,732 - stpipe.Image2Pipeline - INFO - Prefetch for DISPERSER reference file is 'N/A'.
2025-09-13 12:54:36,732 - stpipe.Image2Pipeline - INFO - Prefetch for DISTORTION reference file is '/home/runner/crds/references/jwst/nircam/jwst_nircam_distortion_0313.asdf'.
2025-09-13 12:54:36,733 - stpipe.Image2Pipeline - INFO - Prefetch for FFLAT reference file is 'N/A'.
2025-09-13 12:54:36,733 - stpipe.Image2Pipeline - INFO - Prefetch for FILTEROFFSET reference file is '/home/runner/crds/references/jwst/nircam/jwst_nircam_filteroffset_0005.asdf'.
2025-09-13 12:54:36,734 - stpipe.Image2Pipeline - INFO - Prefetch for FLAT reference file is '/home/runner/crds/references/jwst/nircam/jwst_nircam_flat_0653.fits'.
2025-09-13 12:54:36,734 - stpipe.Image2Pipeline - INFO - Prefetch for FORE reference file is 'N/A'.
2025-09-13 12:54:36,735 - stpipe.Image2Pipeline - INFO - Prefetch for FPA reference file is 'N/A'.
2025-09-13 12:54:36,735 - stpipe.Image2Pipeline - INFO - Prefetch for IFUFORE reference file is 'N/A'.
2025-09-13 12:54:36,736 - stpipe.Image2Pipeline - INFO - Prefetch for IFUPOST reference file is 'N/A'.
2025-09-13 12:54:36,736 - stpipe.Image2Pipeline - INFO - Prefetch for IFUSLICER reference file is 'N/A'.
2025-09-13 12:54:36,737 - stpipe.Image2Pipeline - INFO - Prefetch for MSA reference file is 'N/A'.
2025-09-13 12:54:36,737 - stpipe.Image2Pipeline - INFO - Prefetch for OTE reference file is 'N/A'.
2025-09-13 12:54:36,738 - stpipe.Image2Pipeline - INFO - Prefetch for PHOTOM reference file is '/home/runner/crds/references/jwst/nircam/jwst_nircam_photom_0159.fits'.
2025-09-13 12:54:36,739 - stpipe.Image2Pipeline - INFO - Prefetch for REGIONS reference file is 'N/A'.
2025-09-13 12:54:36,739 - stpipe.Image2Pipeline - INFO - Prefetch for SFLAT reference file is 'N/A'.
2025-09-13 12:54:36,740 - stpipe.Image2Pipeline - INFO - Prefetch for SPECWCS reference file is 'N/A'.
2025-09-13 12:54:36,740 - stpipe.Image2Pipeline - INFO - Prefetch for WAVELENGTHRANGE reference file is 'N/A'.
2025-09-13 12:54:36,740 - stpipe.Image2Pipeline - INFO - Starting calwebb_image2 ...
2025-09-13 12:54:36,741 - stpipe.Image2Pipeline - INFO - Processing product /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRCAM/Imaging/nrc_im_demo_data/Obs001/stage1/jw02739001002_02105_00002_nrca4
2025-09-13 12:54:36,742 - stpipe.Image2Pipeline - INFO - Working on input /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRCAM/Imaging/nrc_im_demo_data/Obs001/stage1/jw02739001002_02105_00002_nrca4_rate.fits ...
2025-09-13 12:54:36,977 - stpipe.Image2Pipeline.assign_wcs - INFO - Step assign_wcs running with args (<ImageModel(2048, 2048) from ./nrc_im_demo_data/Obs001/stage2/jw02739001002_02105_00002_nrca4_image2pipeline.fits>,).
2025-09-13 12:54:37,116 - stcal.alignment.util - INFO - Update S_REGION to POLYGON ICRS  274.714837717 -13.855933420 274.732926148 -13.856599115 274.733740596 -13.839140896 274.715564846 -13.838281130
2025-09-13 12:54:37,117 - jwst.assign_wcs.assign_wcs - INFO - assign_wcs updated S_REGION to POLYGON ICRS  274.714837717 -13.855933420 274.732926148 -13.856599115 274.733740596 -13.839140896 274.715564846 -13.838281130
2025-09-13 12:54:37,117 - jwst.assign_wcs.assign_wcs - INFO - COMPLETED assign_wcs
2025-09-13 12:54:37,146 - py.warnings - WARNING - /usr/share/miniconda/lib/python3.13/site-packages/gwcs/wcs/_wcs.py:1761: UserWarning: Double sampling check FAILED: Sampling may be too coarse for the distortion model being fitted.
  fit_poly_x, fit_poly_y, max_resid = fit_2D_poly(
2025-09-13 12:54:37,167 - stpipe.Image2Pipeline.assign_wcs - INFO - Step assign_wcs done
2025-09-13 12:54:37,366 - stpipe.Image2Pipeline.flat_field - INFO - Step flat_field running with args (<ImageModel(2048, 2048) from ./nrc_im_demo_data/Obs001/stage2/jw02739001002_02105_00002_nrca4_image2pipeline.fits>,).
2025-09-13 12:54:37,422 - stpipe.Image2Pipeline.flat_field - INFO - Using FLAT reference file: /home/runner/crds/references/jwst/nircam/jwst_nircam_flat_0653.fits
2025-09-13 12:54:37,422 - stpipe.Image2Pipeline.flat_field - INFO - No reference found for type FFLAT
2025-09-13 12:54:37,423 - stpipe.Image2Pipeline.flat_field - INFO - No reference found for type SFLAT
2025-09-13 12:54:37,424 - stpipe.Image2Pipeline.flat_field - INFO - No reference found for type DFLAT
2025-09-13 12:54:37,573 - stpipe.Image2Pipeline.flat_field - INFO - Step flat_field done
2025-09-13 12:54:37,774 - stpipe.Image2Pipeline.photom - INFO - Step photom running with args (<ImageModel(2048, 2048) from ./nrc_im_demo_data/Obs001/stage2/jw02739001002_02105_00002_nrca4_image2pipeline.fits>,).
2025-09-13 12:54:37,787 - stpipe.Image2Pipeline.photom - INFO - Using photom reference file: /home/runner/crds/references/jwst/nircam/jwst_nircam_photom_0159.fits
2025-09-13 12:54:37,787 - stpipe.Image2Pipeline.photom - INFO - Using area reference file: /home/runner/crds/references/jwst/nircam/jwst_nircam_area_0290.fits
2025-09-13 12:54:37,813 - jwst.photom.photom - INFO - Using instrument: NIRCAM
2025-09-13 12:54:37,814 - jwst.photom.photom - INFO -  detector: NRCA4
2025-09-13 12:54:37,814 - jwst.photom.photom - INFO -  exp_type: NRC_IMAGE
2025-09-13 12:54:37,815 - jwst.photom.photom - INFO -  filter: F200W
2025-09-13 12:54:37,815 - jwst.photom.photom - INFO -  pupil: CLEAR
2025-09-13 12:54:37,845 - jwst.photom.photom - INFO - Pixel area map copied to output.
2025-09-13 12:54:37,846 - jwst.photom.photom - INFO - Values for PIXAR_SR and PIXAR_A2 obtained from AREA reference file.
2025-09-13 12:54:37,847 - jwst.photom.photom - INFO - PHOTMJSR value: 1.829
2025-09-13 12:54:37,894 - stpipe.Image2Pipeline.photom - INFO - Step photom done
2025-09-13 12:54:38,083 - stpipe.Image2Pipeline.resample - INFO - Step resample running with args (<ImageModel(2048, 2048) from ./nrc_im_demo_data/Obs001/stage2/jw02739001002_02105_00002_nrca4_image2pipeline.fits>,).
2025-09-13 12:54:38,129 - jwst.resample.resample_utils - INFO - Pixel scale ratio (pscale_out/pscale_in): 1.0
2025-09-13 12:54:38,130 - jwst.resample.resample_utils - INFO - Computed output pixel scale: 0.030907888437982967 arcsec.
2025-09-13 12:54:38,137 - stcal.resample.resample - INFO - Output pixel scale: 0.030907888437982967 arcsec.
2025-09-13 12:54:38,137 - stcal.resample.resample - INFO - Driz parameter kernel: square
2025-09-13 12:54:38,138 - stcal.resample.resample - INFO - Driz parameter pixfrac: 1.0
2025-09-13 12:54:38,138 - stcal.resample.resample - INFO - Driz parameter fillval: NAN
2025-09-13 12:54:38,138 - stcal.resample.resample - INFO - Driz parameter weight_type: exptime
2025-09-13 12:54:38,153 - jwst.resample.resample - INFO - Resampling science and variance data
2025-09-13 12:54:40,090 - stcal.resample.resample - INFO - Resampling science and variance data
2025-09-13 12:54:40,918 - stcal.resample.resample - INFO - Drizzling (2048, 2048) --> (2058, 2058)
2025-09-13 12:54:41,715 - stcal.resample.resample - INFO - Drizzling (2048, 2048) --> (2058, 2058)
2025-09-13 12:54:42,521 - stcal.resample.resample - INFO - Drizzling (2048, 2048) --> (2058, 2058)
2025-09-13 12:54:43,682 - stcal.alignment.util - INFO - Update S_REGION to POLYGON ICRS  274.714770361 -13.855934875 274.732951833 -13.856701273 274.733740453 -13.839048862 274.715560358 -13.838282523
2025-09-13 12:54:43,831 - stpipe.Image2Pipeline.resample - INFO - Saved model in ./nrc_im_demo_data/Obs001/stage2/jw02739001002_02105_00002_nrca4_i2d.fits
2025-09-13 12:54:43,832 - stpipe.Image2Pipeline.resample - INFO - Step resample done
2025-09-13 12:54:43,837 - stpipe.Image2Pipeline - INFO - Finished processing product /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRCAM/Imaging/nrc_im_demo_data/Obs001/stage1/jw02739001002_02105_00002_nrca4
2025-09-13 12:54:43,838 - stpipe.Image2Pipeline - INFO - ... ending calwebb_image2
2025-09-13 12:54:43,838 - jwst.stpipe.core - INFO - Results used CRDS context: jwst_1413.pmap
2025-09-13 12:54:44,009 - stpipe.Image2Pipeline - INFO - Saved model in ./nrc_im_demo_data/Obs001/stage2/jw02739001002_02105_00002_nrca4_cal.fits
2025-09-13 12:54:44,009 - stpipe.Image2Pipeline - INFO - Step Image2Pipeline done
2025-09-13 12:54:44,010 - jwst.stpipe.core - INFO - Results used jwst version: 1.19.1
2025-09-13 12:54:44,033 - stpipe - INFO - PARS-RESAMPLESTEP parameters found: /home/runner/crds/references/jwst/nircam/jwst_nircam_pars-resamplestep_0001.asdf
2025-09-13 12:54:44,041 - stpipe - INFO - PARS-IMAGE2PIPELINE parameters found: /home/runner/crds/references/jwst/nircam/jwst_nircam_pars-image2pipeline_0003.asdf
2025-09-13 12:54:44,052 - stpipe.Image2Pipeline - INFO - Image2Pipeline instance created.
2025-09-13 12:54:44,053 - stpipe.Image2Pipeline.bkg_subtract - INFO - BackgroundStep instance created.
2025-09-13 12:54:44,054 - stpipe.Image2Pipeline.assign_wcs - INFO - AssignWcsStep instance created.
2025-09-13 12:54:44,055 - stpipe.Image2Pipeline.flat_field - INFO - FlatFieldStep instance created.
2025-09-13 12:54:44,056 - stpipe.Image2Pipeline.photom - INFO - PhotomStep instance created.
2025-09-13 12:54:44,057 - stpipe.Image2Pipeline.resample - INFO - ResampleStep instance created.
2025-09-13 12:54:44,248 - stpipe.Image2Pipeline - INFO - Step Image2Pipeline running with args ('/home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRCAM/Imaging/nrc_im_demo_data/Obs001/stage1/jw02739001002_02105_00002_nrcalong_rate.fits',).
2025-09-13 12:54:44,255 - stpipe.Image2Pipeline - INFO - Step Image2Pipeline parameters are:
  pre_hooks: []
  post_hooks: []
  output_file: None
  output_dir: ./nrc_im_demo_data/Obs001/stage2
  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: False
      suffix: None
      search_output_file: True
      input_dir: ''
      pixfrac: 1.0
      kernel: square
      fillval: NAN
      weight_type: exptime
      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 12:54:44,275 - stpipe.Image2Pipeline - INFO - Prefetching reference files for dataset: 'jw02739001002_02105_00002_nrcalong_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 12:54:44,278 - stpipe.Image2Pipeline - INFO - Prefetch for AREA reference file is '/home/runner/crds/references/jwst/nircam/jwst_nircam_area_0261.fits'.
2025-09-13 12:54:44,279 - stpipe.Image2Pipeline - INFO - Prefetch for CAMERA reference file is 'N/A'.
2025-09-13 12:54:44,279 - stpipe.Image2Pipeline - INFO - Prefetch for COLLIMATOR reference file is 'N/A'.
2025-09-13 12:54:44,279 - stpipe.Image2Pipeline - INFO - Prefetch for DFLAT reference file is 'N/A'.
2025-09-13 12:54:44,280 - stpipe.Image2Pipeline - INFO - Prefetch for DISPERSER reference file is 'N/A'.
2025-09-13 12:54:44,280 - stpipe.Image2Pipeline - INFO - Prefetch for DISTORTION reference file is '/home/runner/crds/references/jwst/nircam/jwst_nircam_distortion_0277.asdf'.
2025-09-13 12:54:44,280 - stpipe.Image2Pipeline - INFO - Prefetch for FFLAT reference file is 'N/A'.
2025-09-13 12:54:44,281 - stpipe.Image2Pipeline - INFO - Prefetch for FILTEROFFSET reference file is '/home/runner/crds/references/jwst/nircam/jwst_nircam_filteroffset_0007.asdf'.
2025-09-13 12:54:44,281 - stpipe.Image2Pipeline - INFO - Prefetch for FLAT reference file is '/home/runner/crds/references/jwst/nircam/jwst_nircam_flat_0761.fits'.
2025-09-13 12:54:44,282 - stpipe.Image2Pipeline - INFO - Prefetch for FORE reference file is 'N/A'.
2025-09-13 12:54:44,282 - stpipe.Image2Pipeline - INFO - Prefetch for FPA reference file is 'N/A'.
2025-09-13 12:54:44,282 - stpipe.Image2Pipeline - INFO - Prefetch for IFUFORE reference file is 'N/A'.
2025-09-13 12:54:44,283 - stpipe.Image2Pipeline - INFO - Prefetch for IFUPOST reference file is 'N/A'.
2025-09-13 12:54:44,283 - stpipe.Image2Pipeline - INFO - Prefetch for IFUSLICER reference file is 'N/A'.
2025-09-13 12:54:44,283 - stpipe.Image2Pipeline - INFO - Prefetch for MSA reference file is 'N/A'.
2025-09-13 12:54:44,284 - stpipe.Image2Pipeline - INFO - Prefetch for OTE reference file is 'N/A'.
2025-09-13 12:54:44,284 - stpipe.Image2Pipeline - INFO - Prefetch for PHOTOM reference file is '/home/runner/crds/references/jwst/nircam/jwst_nircam_photom_0157.fits'.
2025-09-13 12:54:44,284 - stpipe.Image2Pipeline - INFO - Prefetch for REGIONS reference file is 'N/A'.
2025-09-13 12:54:44,285 - stpipe.Image2Pipeline - INFO - Prefetch for SFLAT reference file is 'N/A'.
2025-09-13 12:54:44,285 - stpipe.Image2Pipeline - INFO - Prefetch for SPECWCS reference file is 'N/A'.
2025-09-13 12:54:44,285 - stpipe.Image2Pipeline - INFO - Prefetch for WAVELENGTHRANGE reference file is 'N/A'.
2025-09-13 12:54:44,286 - stpipe.Image2Pipeline - INFO - Starting calwebb_image2 ...
2025-09-13 12:54:44,286 - stpipe.Image2Pipeline - INFO - Processing product /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRCAM/Imaging/nrc_im_demo_data/Obs001/stage1/jw02739001002_02105_00002_nrcalong
2025-09-13 12:54:44,287 - stpipe.Image2Pipeline - INFO - Working on input /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRCAM/Imaging/nrc_im_demo_data/Obs001/stage1/jw02739001002_02105_00002_nrcalong_rate.fits ...
2025-09-13 12:54:44,520 - stpipe.Image2Pipeline.assign_wcs - INFO - Step assign_wcs running with args (<ImageModel(2048, 2048) from ./nrc_im_demo_data/Obs001/stage2/jw02739001002_02105_00002_nrcalong_image2pipeline.fits>,).
2025-09-13 12:54:44,658 - stcal.alignment.util - INFO - Update S_REGION to POLYGON ICRS  274.695076832 -13.873788833 274.732011188 -13.874819481 274.733563641 -13.839450219 274.696398096 -13.837555458
2025-09-13 12:54:44,659 - jwst.assign_wcs.assign_wcs - INFO - assign_wcs updated S_REGION to POLYGON ICRS  274.695076832 -13.873788833 274.732011188 -13.874819481 274.733563641 -13.839450219 274.696398096 -13.837555458
2025-09-13 12:54:44,660 - jwst.assign_wcs.assign_wcs - INFO - COMPLETED assign_wcs
2025-09-13 12:54:44,711 - stpipe.Image2Pipeline.assign_wcs - INFO - Step assign_wcs done
2025-09-13 12:54:44,901 - stpipe.Image2Pipeline.flat_field - INFO - Step flat_field running with args (<ImageModel(2048, 2048) from ./nrc_im_demo_data/Obs001/stage2/jw02739001002_02105_00002_nrcalong_image2pipeline.fits>,).
2025-09-13 12:54:44,955 - stpipe.Image2Pipeline.flat_field - INFO - Using FLAT reference file: /home/runner/crds/references/jwst/nircam/jwst_nircam_flat_0761.fits
2025-09-13 12:54:44,955 - stpipe.Image2Pipeline.flat_field - INFO - No reference found for type FFLAT
2025-09-13 12:54:44,956 - stpipe.Image2Pipeline.flat_field - INFO - No reference found for type SFLAT
2025-09-13 12:54:44,956 - stpipe.Image2Pipeline.flat_field - INFO - No reference found for type DFLAT
2025-09-13 12:54:45,125 - stpipe.Image2Pipeline.flat_field - INFO - Step flat_field done
2025-09-13 12:54:45,323 - stpipe.Image2Pipeline.photom - INFO - Step photom running with args (<ImageModel(2048, 2048) from ./nrc_im_demo_data/Obs001/stage2/jw02739001002_02105_00002_nrcalong_image2pipeline.fits>,).
2025-09-13 12:54:45,335 - stpipe.Image2Pipeline.photom - INFO - Using photom reference file: /home/runner/crds/references/jwst/nircam/jwst_nircam_photom_0157.fits
2025-09-13 12:54:45,335 - stpipe.Image2Pipeline.photom - INFO - Using area reference file: /home/runner/crds/references/jwst/nircam/jwst_nircam_area_0261.fits
2025-09-13 12:54:45,361 - jwst.photom.photom - INFO - Using instrument: NIRCAM
2025-09-13 12:54:45,362 - jwst.photom.photom - INFO -  detector: NRCALONG
2025-09-13 12:54:45,362 - jwst.photom.photom - INFO -  exp_type: NRC_IMAGE
2025-09-13 12:54:45,363 - jwst.photom.photom - INFO -  filter: F444W
2025-09-13 12:54:45,363 - jwst.photom.photom - INFO -  pupil: CLEAR
2025-09-13 12:54:45,393 - jwst.photom.photom - INFO - Pixel area map copied to output.
2025-09-13 12:54:45,394 - jwst.photom.photom - INFO - Values for PIXAR_SR and PIXAR_A2 obtained from AREA reference file.
2025-09-13 12:54:45,395 - jwst.photom.photom - INFO - PHOTMJSR value: 0.402
2025-09-13 12:54:45,454 - stpipe.Image2Pipeline.photom - INFO - Step photom done
2025-09-13 12:54:45,651 - stpipe.Image2Pipeline.resample - INFO - Step resample running with args (<ImageModel(2048, 2048) from ./nrc_im_demo_data/Obs001/stage2/jw02739001002_02105_00002_nrcalong_image2pipeline.fits>,).
2025-09-13 12:54:45,710 - jwst.resample.resample_utils - INFO - Pixel scale ratio (pscale_out/pscale_in): 1.0
2025-09-13 12:54:45,710 - jwst.resample.resample_utils - INFO - Computed output pixel scale: 0.06290626046665974 arcsec.
2025-09-13 12:54:45,717 - stcal.resample.resample - INFO - Output pixel scale: 0.06290626046665974 arcsec.
2025-09-13 12:54:45,718 - stcal.resample.resample - INFO - Driz parameter kernel: square
2025-09-13 12:54:45,718 - stcal.resample.resample - INFO - Driz parameter pixfrac: 1.0
2025-09-13 12:54:45,719 - stcal.resample.resample - INFO - Driz parameter fillval: NAN
2025-09-13 12:54:45,719 - stcal.resample.resample - INFO - Driz parameter weight_type: exptime
2025-09-13 12:54:45,735 - jwst.resample.resample - INFO - Resampling science and variance data
2025-09-13 12:54:47,692 - stcal.resample.resample - INFO - Resampling science and variance data
2025-09-13 12:54:48,533 - stcal.resample.resample - INFO - Drizzling (2048, 2048) --> (2068, 2075)
2025-09-13 12:54:49,334 - stcal.resample.resample - INFO - Drizzling (2048, 2048) --> (2068, 2075)
2025-09-13 12:54:50,135 - stcal.resample.resample - INFO - Drizzling (2048, 2048) --> (2068, 2075)
2025-09-13 12:54:51,315 - stcal.alignment.util - INFO - Update S_REGION to POLYGON ICRS  274.694871100 -13.873789453 274.732062632 -13.875255387 274.733574602 -13.839026648 274.696388861 -13.837560943
2025-09-13 12:54:51,467 - stpipe.Image2Pipeline.resample - INFO - Saved model in ./nrc_im_demo_data/Obs001/stage2/jw02739001002_02105_00002_nrcalong_i2d.fits
2025-09-13 12:54:51,468 - stpipe.Image2Pipeline.resample - INFO - Step resample done
2025-09-13 12:54:51,473 - stpipe.Image2Pipeline - INFO - Finished processing product /home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRCAM/Imaging/nrc_im_demo_data/Obs001/stage1/jw02739001002_02105_00002_nrcalong
2025-09-13 12:54:51,474 - stpipe.Image2Pipeline - INFO - ... ending calwebb_image2
2025-09-13 12:54:51,475 - jwst.stpipe.core - INFO - Results used CRDS context: jwst_1413.pmap
2025-09-13 12:54:51,648 - stpipe.Image2Pipeline - INFO - Saved model in ./nrc_im_demo_data/Obs001/stage2/jw02739001002_02105_00002_nrcalong_cal.fits
2025-09-13 12:54:51,649 - stpipe.Image2Pipeline - INFO - Step Image2Pipeline done
2025-09-13 12:54:51,649 - jwst.stpipe.core - INFO - Results used jwst version: 1.19.1
# Print out the time benchmark
time1 = time.perf_counter()
print(f"Runtime so far: {time1 - time0:0.0f} seconds")
print(f"Runtime for Image2: {time1 - time_image2:0.0f} seconds")
Runtime so far: 434 seconds
Runtime for Image2: 50 seconds

Verify which pipeline steps were run#

if doimage2:
    # Identify *_cal.fits file products
    cal_files = sorted(glob.glob(os.path.join(image2_dir, '*_cal.fits')))

    # Select first file to gather information
    cal_f = datamodels.open(cal_files[0])

    # Check which steps were run:
    cal_f.meta.cal_step.instance
{'assign_wcs': 'COMPLETE',
 'charge_migration': 'SKIPPED',
 'clean_flicker_noise': 'SKIPPED',
 'dark_sub': 'COMPLETE',
 'dq_init': 'COMPLETE',
 'flat_field': 'COMPLETE',
 'gain_scale': 'SKIPPED',
 'group_scale': 'SKIPPED',
 'ipc': 'SKIPPED',
 'jump': 'COMPLETE',
 'linearity': 'COMPLETE',
 'persistence': 'SKIPPED',
 'photom': 'COMPLETE',
 'ramp_fit': 'COMPLETE',
 'refpix': 'COMPLETE',
 'saturation': 'COMPLETE',
 'superbias': 'COMPLETE'}

Check which reference files were used to calibrate the first file. Some of these will be detector-dependent.

if doimage2:
    cal_f.meta.ref_file.instance
{'area': {'name': 'crds://jwst_nircam_area_0263.fits'},
 'camera': {'name': 'N/A'},
 'collimator': {'name': 'N/A'},
 'crds': {'context_used': 'jwst_1413.pmap', 'sw_version': '13.0.4'},
 'dark': {'name': 'crds://jwst_nircam_dark_0342.fits'},
 'dflat': {'name': 'N/A'},
 'disperser': {'name': 'N/A'},
 'distortion': {'name': 'crds://jwst_nircam_distortion_0268.asdf'},
 'fflat': {'name': 'N/A'},
 'filteroffset': {'name': 'crds://jwst_nircam_filteroffset_0005.asdf'},
 'flat': {'name': 'crds://jwst_nircam_flat_0654.fits'},
 'fore': {'name': 'N/A'},
 'fpa': {'name': 'N/A'},
 'gain': {'name': 'crds://jwst_nircam_gain_0093.fits'},
 'ifufore': {'name': 'N/A'},
 'ifupost': {'name': 'N/A'},
 'ifuslicer': {'name': 'N/A'},
 'linearity': {'name': 'crds://jwst_nircam_linearity_0051.fits'},
 'mask': {'name': 'crds://jwst_nircam_mask_0072.fits'},
 'msa': {'name': 'N/A'},
 'ote': {'name': 'N/A'},
 'photom': {'name': 'crds://jwst_nircam_photom_0152.fits'},
 'readnoise': {'name': 'crds://jwst_nircam_readnoise_0224.fits'},
 'regions': {'name': 'N/A'},
 'saturation': {'name': 'crds://jwst_nircam_saturation_0104.fits'},
 'sflat': {'name': 'N/A'},
 'sirskernel': {'name': 'crds://jwst_nircam_sirskernel_0002.asdf'},
 'specwcs': {'name': 'N/A'},
 'superbias': {'name': 'crds://jwst_nircam_superbias_0186.fits'},
 'wavelengthrange': {'name': 'N/A'}}

7. Image3 Pipeline#

In the Image3 stage of the pipeline, the individual *_cal.fits files for each filter are combined to one single distortion corrected image. Unlike the previous stages, we must run the Image3 stage separately for the files from each filter as well as channel (i.e. shortwave vs longwave).

First, we need to create Associations, to inform the pipeline which files are linked together for each filter.

By default, the Image3 stage of the pipeline performs the following steps on NIRCam 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.

    • tweakreg has many input parameters that can be adjusted to improve the image alignment in cases where the default values do not perform well.

    • One tweakreg parameter that is not set by default but can be very useful is abs_refcat. When this parameter is set to GAIADR3, the tweakreg step performs an absolute astrometric correction of the data using the GAIA data release 3 catalog. In cases where multiple unsaturated GAIA stars are present in the input images, this can improve the absolute astrometric alignment. However, in sparse or very crowded fields, this can potentially result in poor performance, 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 in the tweakreg step is IRAFStarFinder. Other options include DAOStarFinder, whose results are not as good in cases where the PSF is undersampled, such as in the blue filters of the NIRCam shortwave channel. Finally photutils segmentation SourceFinder, which does not assume sources are point-like.

  • 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 photometric results and morphologies (i.e., point-like vs extended). These catalogs are generally useful for quick checks, but optimization is likely needed for specific science cases. 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()
# Set up a dictionary to define how the Image3 pipeline should be configured

# Boilerplate dictionary setup
image3dict = {}
image3dict['assign_mtwcs'], image3dict['tweakreg'], image3dict['skymatch'] = {}, {}, {}
image3dict['outlier_detection'], image3dict['resample'], image3dict['source_catalog'] = {}, {}, {}

# Overrides for whether or not certain steps should be skipped (example)
#image3dict['outlier_detection']['skip'] = True

# 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)

# Turn on alignment to GAIA in the tweakreg step
# For data such as these demo data, where there are some heavily saturated stars in the field
# of view, alignment to GAIA sometimes does not work well due to tweakreg doing a poor job
# finding the centroids of the sources.
#image3dict['tweakreg']['abs_refcat'] = 'GAIADR3'

Find and sort all of the input files, ensuring use of absolute paths. Keep files for the two filters separated.

# Science Files need the cal.fits files
sw_sstring = os.path.join(image2_dir, 'jw*nrc??_cal.fits')     # shortwave files. Detectors a1-a4, b1-b4
lw_sstring = os.path.join(image2_dir, 'jw*nrc*long_cal.fits')  # longwave files. Detectors along, blong 

# Identify SW and LW cal files
sw_cal_files = sorted(glob.glob(sw_sstring))
lw_cal_files = sorted(glob.glob(lw_sstring))

# Expand the relative paths into absolute paths
sw_cal_files = [os.path.abspath(fname) for fname in sw_cal_files]
lw_cal_files = [os.path.abspath(fname) for fname in lw_cal_files]

print(f'Found {len(sw_cal_files)} shortwave science files to process')
print(f'Found {len(lw_cal_files)} longwave science files to process')
Found 4 shortwave science files to process
Found 2 longwave science files to process

Create Association File#

An association file lists the files to calibrate together in Stage3 of the pipeline. Note that association files are available for download from MAST, with filenames of *_asn.json. Here we show how to create an association file to point to the data products created in the steps above. This is useful in cases where you want to work with a set of data that is different than that in the association files from MAST.

Note that the output products will have a rootname that is specified by the product_name in the association file. For this tutorial, the rootnames of the output products will be image3_sw for filter F200W and image3_lw for filter F444W.

# List of data to use
print('List of SW cal files to use:')
sw_cal_files
print('\nList of LW cal files to use:')
lw_cal_files
List of SW cal files to use:
['/home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRCAM/Imaging/nrc_im_demo_data/Obs001/stage2/jw02739001002_02105_00001_nrca2_cal.fits',
 '/home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRCAM/Imaging/nrc_im_demo_data/Obs001/stage2/jw02739001002_02105_00001_nrca4_cal.fits',
 '/home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRCAM/Imaging/nrc_im_demo_data/Obs001/stage2/jw02739001002_02105_00002_nrca2_cal.fits',
 '/home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRCAM/Imaging/nrc_im_demo_data/Obs001/stage2/jw02739001002_02105_00002_nrca4_cal.fits']
List of LW cal files to use:
['/home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRCAM/Imaging/nrc_im_demo_data/Obs001/stage2/jw02739001002_02105_00001_nrcalong_cal.fits',
 '/home/runner/work/jwst-pipeline-notebooks/jwst-pipeline-notebooks/notebooks/NIRCAM/Imaging/nrc_im_demo_data/Obs001/stage2/jw02739001002_02105_00002_nrcalong_cal.fits']
# Create Level 3 Association for SW products
do_swimage3 = False
if doimage3:
    if len(sw_cal_files) > 0:
        # Only create an association file if there are SW data files to process
        do_swimage3 = True
        sw_product_name = 'image3_sw'
        sw_association = asn_from_list.asn_from_list(sw_cal_files,
                                                     rule=DMS_Level3_Base,
                                                     product_name=sw_product_name)
    
        sw_association.data['asn_type'] = 'image3'
        program = datamodels.open(sw_cal_files[0]).meta.observation.program_number
        sw_association.data['program'] = program
    
        # Format association as .json file
        sw_asn_filename, sw_serialized = sw_association.dump(format="json")

        # Write out association file
        sw_association_im3 = os.path.join(sci_dir, sw_asn_filename)
        with open(sw_association_im3, "w") as fd:
            fd.write(sw_serialized)
1533
# Create Level 3 Associations for LW products
do_lwimage3 = False
if doimage3:
    if len(lw_cal_files) > 0:
        # Only create an association file if there are SW data files to process
        do_lwimage3 = True
        lw_product_name = 'image3_lw'
        lw_association = asn_from_list.asn_from_list(lw_cal_files,
                                                     rule=DMS_Level3_Base,
                                                     product_name=lw_product_name)
    
        lw_association.data['asn_type'] = 'image3'
        program = datamodels.open(lw_cal_files[0]).meta.observation.program_number
        lw_association.data['program'] = program
    
        # Format association as .json file
        lw_asn_filename, lw_serialized = lw_association.dump(format="json")

        # Write out association file. Note that you can use your own filename in
        # place of lw_asn_filename and everything will still work.
        lw_association_im3 = os.path.join(sci_dir, lw_asn_filename)
        with open(lw_association_im3, "w") as fd:
            fd.write(lw_serialized)
989

Run Image3 stage of the pipeline#

For each set of grouped exposures in an association file, the Image3 stage of the pipeline will produce:

  • a *_crf.fits file produced by the outlier_detection step, where the DQ array marks the pixels flagged as outliers.

  • a final combined, rectified image with name *_i2d.fits,

  • a source catalog with name *_cat.ecsv,

  • a segmentation map file (*_segm.fits) which has integer values at the pixel locations where a source is detected where the pixel values match the source ID number in the catalog.

Run Image3 on the LW data#

# Run Stage3 on the LW data
if doimage3 and do_lwimage3:
    lw_i2d_result = Image3Pipeline.call(lw_association_im3, output_dir=image3_dir, steps=image3dict, save_results=True)
else:
    print('Skipping Image3 LW processing')
2025-09-13 12:54:52,073 - CRDS - INFO -  Fetching  /home/runner/crds/references/jwst/nircam/jwst_nircam_pars-tweakregstep_0045.asdf    1.6 K bytes  (1 / 1 files) (0 / 1.6 K bytes)
2025-09-13 12:54:52,123 - stpipe - INFO - PARS-TWEAKREGSTEP parameters found: /home/runner/crds/references/jwst/nircam/jwst_nircam_pars-tweakregstep_0045.asdf
2025-09-13 12:54:52,134 - stpipe - INFO - PARS-RESAMPLESTEP parameters found: /home/runner/crds/references/jwst/nircam/jwst_nircam_pars-resamplestep_0001.asdf
2025-09-13 12:54:52,142 - CRDS - INFO -  Fetching  /home/runner/crds/references/jwst/nircam/jwst_nircam_pars-sourcecatalogstep_0001.asdf      992 bytes  (1 / 1 files) (0 / 992 bytes)
2025-09-13 12:54:52,182 - stpipe - INFO - PARS-SOURCECATALOGSTEP parameters found: /home/runner/crds/references/jwst/nircam/jwst_nircam_pars-sourcecatalogstep_0001.asdf
2025-09-13 12:54:52,196 - stpipe.Image3Pipeline - INFO - Image3Pipeline instance created.
2025-09-13 12:54:52,197 - stpipe.Image3Pipeline.assign_mtwcs - INFO - AssignMTWcsStep instance created.
2025-09-13 12:54:52,199 - stpipe.Image3Pipeline.tweakreg - INFO - TweakRegStep instance created.
2025-09-13 12:54:52,201 - stpipe.Image3Pipeline.skymatch - INFO - SkyMatchStep instance created.
2025-09-13 12:54:52,202 - stpipe.Image3Pipeline.outlier_detection - INFO - OutlierDetectionStep instance created.
2025-09-13 12:54:52,203 - stpipe.Image3Pipeline.resample - INFO - ResampleStep instance created.
2025-09-13 12:54:52,205 - stpipe.Image3Pipeline.source_catalog - INFO - SourceCatalogStep instance created.
2025-09-13 12:54:52,407 - stpipe.Image3Pipeline - INFO - Step Image3Pipeline running with args ('./nrc_im_demo_data/Obs001/jw02739-a3001_image3_00009_asn.json',).
2025-09-13 12:54:52,419 - stpipe.Image3Pipeline - INFO - Step Image3Pipeline parameters are:
  pre_hooks: []
  post_hooks: []
  output_file: None
  output_dir: ./nrc_im_demo_data/Obs001/stage3
  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.0
      kernel_fwhm: 2.302
      bkg_boxsize: 400
      minsep_fwhm: 0.0
      sigma_radius: 1.5
      sharplo: 0.5
      sharphi: 2.0
      roundlo: 0.0
      roundhi: 0.2
      brightest: 200
      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: 15
      fitgeometry: shift
      nclip: 3
      sigma: 3.0
      searchrad: 2.0
      use2dhist: True
      separation: 2.0
      tolerance: 1.0
      xoffset: 0.0
      yoffset: 0.0
      abs_refcat: ''
      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: 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
    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: exptime
      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: 1000
      kernel_fwhm: 2.302
      snr_threshold: 3.0
      npixels: 25
      deblend: False
      aperture_ee1: 30
      aperture_ee2: 50
      aperture_ee3: 70
      ci1_star_threshold: 2.0
      ci2_star_threshold: 1.8
2025-09-13 12:54:52,480 - stpipe.Image3Pipeline - INFO - Prefetching reference files for dataset: 'jw02739-a3001_image3_00009_asn.json' reftypes = ['abvegaoffset', 'apcorr']
2025-09-13 12:54:52,482 - CRDS - INFO -  Fetching  /home/runner/crds/references/jwst/nircam/jwst_nircam_abvegaoffset_0002.asdf    4.3 K bytes  (1 / 2 files) (0 / 24.5 K bytes)
2025-09-13 12:54:52,513 - CRDS - INFO -  Fetching  /home/runner/crds/references/jwst/nircam/jwst_nircam_apcorr_0004.fits   20.2 K bytes  (2 / 2 files) (4.3 K / 24.5 K bytes)
2025-09-13 12:54:52,560 - stpipe.Image3Pipeline - INFO - Prefetch for ABVEGAOFFSET reference file is '/home/runner/crds/references/jwst/nircam/jwst_nircam_abvegaoffset_0002.asdf'.
2025-09-13 12:54:52,561 - stpipe.Image3Pipeline - INFO - Prefetch for APCORR reference file is '/home/runner/crds/references/jwst/nircam/jwst_nircam_apcorr_0004.fits'.
2025-09-13 12:54:52,561 - stpipe.Image3Pipeline - INFO - Starting calwebb_image3 ...
2025-09-13 12:54:52,910 - stpipe.Image3Pipeline.tweakreg - INFO - Step tweakreg running with args (<jwst.datamodels.library.ModelLibrary object at 0x7fcacbfb3450>,).
2025-09-13 12:54:54,473 - stpipe.Image3Pipeline.tweakreg - INFO - Detected 200 sources in jw02739001002_02105_00001_nrcalong_cal.fits.
2025-09-13 12:54:56,144 - stpipe.Image3Pipeline.tweakreg - INFO - Detected 200 sources in jw02739001002_02105_00002_nrcalong_cal.fits.
2025-09-13 12:54:56,166 - stpipe.Image3Pipeline.tweakreg - INFO - 
2025-09-13 12:54:56,167 - stpipe.Image3Pipeline.tweakreg - INFO - Number of image groups to be aligned: 2.
2025-09-13 12:54:56,167 - tweakwcs.imalign - INFO -  
2025-09-13 12:54:56,168 - tweakwcs.imalign - INFO - ***** tweakwcs.imalign.align_wcs() started on 2025-09-13 12:54:56.167909
2025-09-13 12:54:56,168 - tweakwcs.imalign - INFO -       Version 0.8.11
2025-09-13 12:54:56,169 - tweakwcs.imalign - INFO -  
2025-09-13 12:54:56,674 - tweakwcs.imalign - INFO - Selected image 'GROUP ID: jw02739001002_02105_1' as reference image
2025-09-13 12:54:56,679 - tweakwcs.imalign - INFO - Aligning image catalog 'GROUP ID: jw02739001002_02105_2' to the reference catalog.
2025-09-13 12:54:56,716 - tweakwcs.matchutils - INFO - Matching sources from 'jw02739001002_02105_00002_nrcalong_cal' catalog with sources from the reference 'jw02739001002_02105_00001_nrcalong_cal' catalog.
2025-09-13 12:54:56,716 - tweakwcs.matchutils - INFO - Computing initial guess for X and Y shifts...
2025-09-13 12:54:56,718 - tweakwcs.matchutils - INFO - Found initial X and Y shifts of 0.013, 0.013 (arcsec) with significance of 121 and 121 matches.
2025-09-13 12:54:56,719 - tweakwcs.wcsimage - INFO - Found 117 matches for 'GROUP ID: jw02739001002_02105_2'...
2025-09-13 12:54:56,719 - tweakwcs.linearfit - INFO - Performing 'shift' fit
2025-09-13 12:54:56,722 - tweakwcs.wcsimage - INFO - Computed 'shift' fit for GROUP ID: jw02739001002_02105_2:
2025-09-13 12:54:56,722 - tweakwcs.wcsimage - INFO - XSH: -0.00280646  YSH: 0.0015954
2025-09-13 12:54:56,723 - tweakwcs.wcsimage - INFO - 
2025-09-13 12:54:56,723 - tweakwcs.wcsimage - INFO - FIT RMSE: 0.0408589   FIT MAE: 0.0127893
2025-09-13 12:54:56,723 - tweakwcs.wcsimage - INFO - Final solution based on 113 objects.
2025-09-13 12:54:56,754 - tweakwcs.imalign - INFO -  
2025-09-13 12:54:56,755 - tweakwcs.imalign - INFO - ***** tweakwcs.imalign.align_wcs() ended on 2025-09-13 12:54:56.754634
2025-09-13 12:54:56,755 - tweakwcs.imalign - INFO - ***** tweakwcs.imalign.align_wcs() TOTAL RUN TIME: 0:00:00.586725
2025-09-13 12:54:56,755 - tweakwcs.imalign - INFO -  
2025-09-13 12:54:56,807 - stcal.alignment.util - INFO - Update S_REGION to POLYGON ICRS  274.695076029 -13.873788389 274.732010385 -13.874819038 274.733562838 -13.839449776 274.696397293 -13.837555015
2025-09-13 12:54:56,860 - stpipe.Image3Pipeline.tweakreg - INFO - Step tweakreg done
2025-09-13 12:54:57,054 - stpipe.Image3Pipeline.skymatch - INFO - Step skymatch running with args (<jwst.datamodels.library.ModelLibrary object at 0x7fcacbfb3450>,).
2025-09-13 12:54:57,097 - stcal.skymatch.skymatch - INFO -  
2025-09-13 12:54:57,098 - stcal.skymatch.skymatch - INFO - ***** stcal.skymatch.skymatch.skymatch() started on 2025-09-13 12:54:57.097626
2025-09-13 12:54:57,098 - stcal.skymatch.skymatch - INFO -  
2025-09-13 12:54:57,099 - stcal.skymatch.skymatch - INFO - Sky computation method: 'match'
2025-09-13 12:54:57,099 - stcal.skymatch.skymatch - INFO - Sky matching direction: DOWN
2025-09-13 12:54:57,099 - stcal.skymatch.skymatch - INFO - Sky subtraction from image data: OFF
2025-09-13 12:54:57,100 - stcal.skymatch.skymatch - INFO -  
2025-09-13 12:54:57,101 - stcal.skymatch.skymatch - INFO - ----  Computing differences in sky values in overlapping regions.
2025-09-13 12:54:57,417 - stcal.skymatch.skymatch - INFO -    *  Image ID=jw02739001002_02105_00001_nrcalong_cal.fits. Sky background: 0
2025-09-13 12:54:57,418 - stcal.skymatch.skymatch - INFO -    *  Image ID=jw02739001002_02105_00002_nrcalong_cal.fits. Sky background: 0.0125647
2025-09-13 12:54:57,419 - stcal.skymatch.skymatch - INFO -  
2025-09-13 12:54:57,419 - stcal.skymatch.skymatch - INFO - ***** stcal.skymatch.skymatch.skymatch() ended on 2025-09-13 12:54:57.419203
2025-09-13 12:54:57,420 - stcal.skymatch.skymatch - INFO - ***** stcal.skymatch.skymatch.skymatch() TOTAL RUN TIME: 0:00:00.321577
2025-09-13 12:54:57,420 - stcal.skymatch.skymatch - INFO -  
2025-09-13 12:54:57,425 - stpipe.Image3Pipeline.skymatch - INFO - Step skymatch done
2025-09-13 12:54:57,619 - stpipe.Image3Pipeline.outlier_detection - INFO - Step outlier_detection running with args (<jwst.datamodels.library.ModelLibrary object at 0x7fcacbfb3450>,).
2025-09-13 12:54:57,620 - stpipe.Image3Pipeline.outlier_detection - INFO - Outlier Detection mode: imaging
2025-09-13 12:54:57,621 - stpipe.Image3Pipeline.outlier_detection - INFO - Outlier Detection asn_id: a3001
2025-09-13 12:54:57,643 - jwst.resample.resample_utils - INFO - Pixel scale ratio (pscale_out/pscale_in): 1.0
2025-09-13 12:54:57,644 - jwst.resample.resample_utils - INFO - Computed output pixel scale: 0.06290626049410467 arcsec.
2025-09-13 12:54:57,652 - stcal.resample.resample - INFO - Output pixel scale: 0.06290626049410467 arcsec.
2025-09-13 12:54:57,653 - stcal.resample.resample - INFO - Driz parameter kernel: square
2025-09-13 12:54:57,653 - stcal.resample.resample - INFO - Driz parameter pixfrac: 1.0
2025-09-13 12:54:57,654 - stcal.resample.resample - INFO - Driz parameter fillval: NAN
2025-09-13 12:54:57,654 - stcal.resample.resample - INFO - Driz parameter weight_type: ivm
2025-09-13 12:54:57,656 - jwst.resample.resample - INFO - 1 exposures to drizzle together
2025-09-13 12:54:59,609 - stcal.resample.resample - INFO - Resampling science and variance data
2025-09-13 12:55:00,505 - stcal.alignment.util - INFO - Update S_REGION to POLYGON ICRS  274.691783335 -13.873667066 274.732068138 -13.875255351 274.733582459 -13.838974241 274.693303937 -13.837386204
2025-09-13 12:55:00,825 - jwst.resample.resample - INFO - 1 exposures to drizzle together
2025-09-13 12:55:03,348 - stcal.resample.resample - INFO - Resampling science and variance data
2025-09-13 12:55:04,269 - stcal.alignment.util - INFO - Update S_REGION to POLYGON ICRS  274.691783335 -13.873667066 274.732068138 -13.875255351 274.733582459 -13.838974241 274.693303937 -13.837386204
2025-09-13 12:55:07,773 - stcal.outlier_detection.utils - INFO - Blotting (2048, 2048) <-- (2240, 2078)
2025-09-13 12:55:08,002 - jwst.outlier_detection.utils - INFO - 792 pixels marked as outliers
2025-09-13 12:55:10,660 - stcal.outlier_detection.utils - INFO - Blotting (2048, 2048) <-- (2240, 2078)
2025-09-13 12:55:10,890 - jwst.outlier_detection.utils - INFO - 526 pixels marked as outliers
2025-09-13 12:55:11,099 - stpipe.Image3Pipeline.outlier_detection - INFO - Saved model in ./nrc_im_demo_data/Obs001/stage3/jw02739001002_02105_00001_nrcalong_a3001_crf.fits
2025-09-13 12:55:11,280 - stpipe.Image3Pipeline.outlier_detection - INFO - Saved model in ./nrc_im_demo_data/Obs001/stage3/jw02739001002_02105_00002_nrcalong_a3001_crf.fits
2025-09-13 12:55:11,281 - stpipe.Image3Pipeline.outlier_detection - INFO - Step outlier_detection done
2025-09-13 12:55:11,476 - stpipe.Image3Pipeline.resample - INFO - Step resample running with args (<jwst.datamodels.library.ModelLibrary object at 0x7fcacbfb3450>,).
2025-09-13 12:55:11,577 - jwst.resample.resample_utils - INFO - Pixel scale ratio (pscale_out/pscale_in): 1.0
2025-09-13 12:55:11,578 - jwst.resample.resample_utils - INFO - Computed output pixel scale: 0.06290626049410467 arcsec.
2025-09-13 12:55:11,587 - stcal.resample.resample - INFO - Output pixel scale: 0.06290626049410467 arcsec.
2025-09-13 12:55:11,588 - stcal.resample.resample - INFO - Driz parameter kernel: square
2025-09-13 12:55:11,588 - stcal.resample.resample - INFO - Driz parameter pixfrac: 1.0
2025-09-13 12:55:11,588 - stcal.resample.resample - INFO - Driz parameter fillval: NAN
2025-09-13 12:55:11,589 - stcal.resample.resample - INFO - Driz parameter weight_type: exptime
2025-09-13 12:55:11,606 - jwst.resample.resample - INFO - Resampling science and variance data
2025-09-13 12:55:13,533 - stcal.resample.resample - INFO - Resampling science and variance data
2025-09-13 12:55:14,376 - stcal.resample.resample - INFO - Drizzling (2048, 2048) --> (2240, 2078)
2025-09-13 12:55:15,217 - stcal.resample.resample - INFO - Drizzling (2048, 2048) --> (2240, 2078)
2025-09-13 12:55:16,022 - stcal.resample.resample - INFO - Drizzling (2048, 2048) --> (2240, 2078)
2025-09-13 12:55:19,618 - stcal.resample.resample - INFO - Resampling science and variance data
2025-09-13 12:55:20,458 - stcal.resample.resample - INFO - Drizzling (2048, 2048) --> (2240, 2078)
2025-09-13 12:55:21,258 - stcal.resample.resample - INFO - Drizzling (2048, 2048) --> (2240, 2078)
2025-09-13 12:55:22,059 - stcal.resample.resample - INFO - Drizzling (2048, 2048) --> (2240, 2078)
2025-09-13 12:55:23,365 - stcal.alignment.util - INFO - Update S_REGION to POLYGON ICRS  274.691783335 -13.873667066 274.732068138 -13.875255351 274.733582459 -13.838974241 274.693303937 -13.837386204
2025-09-13 12:55:23,651 - stpipe.Image3Pipeline.resample - INFO - Saved model in ./nrc_im_demo_data/Obs001/stage3/image3_lw_i2d.fits
2025-09-13 12:55:23,651 - stpipe.Image3Pipeline.resample - INFO - Step resample done
2025-09-13 12:55:23,872 - stpipe.Image3Pipeline.source_catalog - INFO - Step source_catalog running with args (<ImageModel(2240, 2078) from image3_lw_i2d.fits>,).
2025-09-13 12:55:23,892 - stpipe.Image3Pipeline.source_catalog - INFO - Using APCORR reference file: /home/runner/crds/references/jwst/nircam/jwst_nircam_apcorr_0004.fits
2025-09-13 12:55:23,894 - stpipe.Image3Pipeline.source_catalog - INFO - Using ABVEGAOFFSET reference file: /home/runner/crds/references/jwst/nircam/jwst_nircam_abvegaoffset_0002.asdf
2025-09-13 12:55:23,895 - jwst.source_catalog.reference_data - INFO - Instrument: NIRCAM
2025-09-13 12:55:23,895 - jwst.source_catalog.reference_data - INFO - Detector: NRCALONG
2025-09-13 12:55:23,896 - jwst.source_catalog.reference_data - INFO - Filter: F444W
2025-09-13 12:55:23,896 - jwst.source_catalog.reference_data - INFO - Pupil: CLEAR
2025-09-13 12:55:23,896 - jwst.source_catalog.reference_data - INFO - Subarray: FULL
2025-09-13 12:55:23,934 - jwst.source_catalog.reference_data - INFO - AB to Vega magnitude offset 3.23800
2025-09-13 12:55:27,265 - jwst.source_catalog.detection - INFO - Detected 1494 sources
2025-09-13 12:55:28,393 - stpipe.Image3Pipeline.source_catalog - INFO - Wrote source catalog: ./nrc_im_demo_data/Obs001/stage3/image3_lw_cat.ecsv
2025-09-13 12:55:28,499 - stpipe.Image3Pipeline.source_catalog - INFO - Saved model in ./nrc_im_demo_data/Obs001/stage3/image3_lw_segm.fits
2025-09-13 12:55:28,500 - stpipe.Image3Pipeline.source_catalog - INFO - Wrote segmentation map: image3_lw_segm.fits
2025-09-13 12:55:28,502 - stpipe.Image3Pipeline.source_catalog - INFO - Step source_catalog done
2025-09-13 12:55:28,512 - stpipe.Image3Pipeline - INFO - Step Image3Pipeline done
2025-09-13 12:55:28,512 - jwst.stpipe.core - INFO - Results used jwst version: 1.19.1

Some users wish to resample data from multiple filters onto the same WCS and pixel grid in order to create color images or help with subsequent analyses. In order to do that, we’ll save the gWCS from the *i2d.fits file created with the LW data above. The gWCS will be saved into an asdf file.

if doimage3 and do_lwimage3:
    # First we identify the dataset and read it using datamodels.
    lw_i2d_file = os.path.join(image3_dir, f'{lw_product_name}_i2d.fits')
    lw_data = datamodels.open(lw_i2d_file)
    
    # Pull out the resulting gWCS and save it in an asdf file
    tree = {"wcs": lw_data.meta.wcs}
    wcs_file = AsdfFile(tree)
    gwcs_filename = os.path.join(image3_dir + 'lw_gwcs.asdf')
    print(f'Saving gWCS into {gwcs_filename}')
    wcs_file.write_to(gwcs_filename)

    # Get the size of the mosaic image
    ysize, xsize = lw_data.data.shape
Saving gWCS into ./nrc_im_demo_data/Obs001/stage3lw_gwcs.asdf

Run Image3 on the SW data#

Prepare to call the Image3 pipeline on the SW data. If you wish to resample the SW data onto the same pixel grid as the LW data above, uncomment the lines below. This will tell the resample step to use the gWCS and the array size from the LW data when resampling the SW data.

# Uncoment this cell in order to resample the SW data onto the same pixel grid as the LW data
#if doimage3:
#    image3dict['resample']['output_wcs'] = gwcs_filename
#    image3dict['resample']['output_shape'] = (xsize, ysize)
if doimage3 and do_swimage3:
    sw_i2d_result = Image3Pipeline.call(sw_association_im3, output_dir=image3_dir, steps=image3dict, save_results=True)
else:
    print('Skipping Image3 SW processing')
2025-09-13 12:55:28,724 - 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 12:55:28,780 - CRDS - INFO -  Fetching  /home/runner/crds/references/jwst/nircam/jwst_nircam_pars-tweakregstep_0036.asdf    1.6 K bytes  (1 / 1 files) (0 / 1.6 K bytes)
2025-09-13 12:55:28,821 - stpipe - INFO - PARS-TWEAKREGSTEP parameters found: /home/runner/crds/references/jwst/nircam/jwst_nircam_pars-tweakregstep_0036.asdf
2025-09-13 12:55:28,832 - stpipe - INFO - PARS-RESAMPLESTEP parameters found: /home/runner/crds/references/jwst/nircam/jwst_nircam_pars-resamplestep_0001.asdf
2025-09-13 12:55:28,840 - CRDS - INFO -  Fetching  /home/runner/crds/references/jwst/nircam/jwst_nircam_pars-sourcecatalogstep_0007.asdf      992 bytes  (1 / 1 files) (0 / 992 bytes)
2025-09-13 12:55:28,889 - stpipe - INFO - PARS-SOURCECATALOGSTEP parameters found: /home/runner/crds/references/jwst/nircam/jwst_nircam_pars-sourcecatalogstep_0007.asdf
2025-09-13 12:55:28,902 - stpipe.Image3Pipeline - INFO - Image3Pipeline instance created.
2025-09-13 12:55:28,903 - stpipe.Image3Pipeline.assign_mtwcs - INFO - AssignMTWcsStep instance created.
2025-09-13 12:55:28,905 - stpipe.Image3Pipeline.tweakreg - INFO - TweakRegStep instance created.
2025-09-13 12:55:28,906 - stpipe.Image3Pipeline.skymatch - INFO - SkyMatchStep instance created.
2025-09-13 12:55:28,907 - stpipe.Image3Pipeline.outlier_detection - INFO - OutlierDetectionStep instance created.
2025-09-13 12:55:28,908 - stpipe.Image3Pipeline.resample - INFO - ResampleStep instance created.
2025-09-13 12:55:28,909 - stpipe.Image3Pipeline.source_catalog - INFO - SourceCatalogStep instance created.
2025-09-13 12:55:29,115 - stpipe.Image3Pipeline - INFO - Step Image3Pipeline running with args ('./nrc_im_demo_data/Obs001/jw02739-a3001_image3_00008_asn.json',).
2025-09-13 12:55:29,127 - stpipe.Image3Pipeline - INFO - Step Image3Pipeline parameters are:
  pre_hooks: []
  post_hooks: []
  output_file: None
  output_dir: ./nrc_im_demo_data/Obs001/stage3
  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.0
      kernel_fwhm: 2.141
      bkg_boxsize: 400
      minsep_fwhm: 0.0
      sigma_radius: 1.5
      sharplo: 0.5
      sharphi: 2.0
      roundlo: 0.0
      roundhi: 0.2
      brightest: 200
      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: 15
      fitgeometry: shift
      nclip: 3
      sigma: 3.0
      searchrad: 2.0
      use2dhist: True
      separation: 2.0
      tolerance: 1.0
      xoffset: 0.0
      yoffset: 0.0
      abs_refcat: ''
      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: 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
    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: exptime
      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: 1000
      kernel_fwhm: 2.141
      snr_threshold: 3.0
      npixels: 25
      deblend: False
      aperture_ee1: 30
      aperture_ee2: 50
      aperture_ee3: 70
      ci1_star_threshold: 2.0
      ci2_star_threshold: 1.8
2025-09-13 12:55:29,187 - stpipe.Image3Pipeline - INFO - Prefetching reference files for dataset: 'jw02739-a3001_image3_00008_asn.json' reftypes = ['abvegaoffset', 'apcorr']
2025-09-13 12:55:29,189 - stpipe.Image3Pipeline - INFO - Prefetch for ABVEGAOFFSET reference file is '/home/runner/crds/references/jwst/nircam/jwst_nircam_abvegaoffset_0002.asdf'.
2025-09-13 12:55:29,190 - stpipe.Image3Pipeline - INFO - Prefetch for APCORR reference file is '/home/runner/crds/references/jwst/nircam/jwst_nircam_apcorr_0004.fits'.
2025-09-13 12:55:29,190 - stpipe.Image3Pipeline - INFO - Starting calwebb_image3 ...
2025-09-13 12:55:29,599 - stpipe.Image3Pipeline.tweakreg - INFO - Step tweakreg running with args (<jwst.datamodels.library.ModelLibrary object at 0x7fcacc1e1130>,).
2025-09-13 12:55:31,510 - stpipe.Image3Pipeline.tweakreg - INFO - Detected 200 sources in jw02739001002_02105_00001_nrca2_cal.fits.
2025-09-13 12:55:33,347 - stpipe.Image3Pipeline.tweakreg - INFO - Detected 200 sources in jw02739001002_02105_00001_nrca4_cal.fits.
2025-09-13 12:55:35,335 - stpipe.Image3Pipeline.tweakreg - INFO - Detected 200 sources in jw02739001002_02105_00002_nrca2_cal.fits.
2025-09-13 12:55:37,185 - stpipe.Image3Pipeline.tweakreg - INFO - Detected 200 sources in jw02739001002_02105_00002_nrca4_cal.fits.
2025-09-13 12:55:37,207 - stpipe.Image3Pipeline.tweakreg - INFO - 
2025-09-13 12:55:37,207 - stpipe.Image3Pipeline.tweakreg - INFO - Number of image groups to be aligned: 2.
2025-09-13 12:55:37,208 - tweakwcs.imalign - INFO -  
2025-09-13 12:55:37,208 - tweakwcs.imalign - INFO - ***** tweakwcs.imalign.align_wcs() started on 2025-09-13 12:55:37.207996
2025-09-13 12:55:37,208 - tweakwcs.imalign - INFO -       Version 0.8.11
2025-09-13 12:55:37,209 - tweakwcs.imalign - INFO -  
2025-09-13 12:55:38,054 - tweakwcs.imalign - INFO - Selected image 'GROUP ID: jw02739001002_02105_1' as reference image
2025-09-13 12:55:38,059 - tweakwcs.imalign - INFO - Aligning image catalog 'GROUP ID: jw02739001002_02105_2' to the reference catalog.
2025-09-13 12:55:38,095 - tweakwcs.matchutils - INFO - Matching sources from 'jw02739001002_02105_00002_nrca' catalog with sources from the reference 'jw02739001002_02105_00001_nrca' catalog.
2025-09-13 12:55:38,096 - tweakwcs.matchutils - INFO - Computing initial guess for X and Y shifts...
2025-09-13 12:55:38,098 - tweakwcs.matchutils - INFO - Found initial X and Y shifts of 0.0004421, 0.0004421 (arcsec) with significance of 294.4 and 295 matches.
2025-09-13 12:55:38,099 - tweakwcs.wcsimage - INFO - Found 225 matches for 'GROUP ID: jw02739001002_02105_2'...
2025-09-13 12:55:38,100 - tweakwcs.linearfit - INFO - Performing 'shift' fit
2025-09-13 12:55:38,102 - tweakwcs.wcsimage - INFO - Computed 'shift' fit for GROUP ID: jw02739001002_02105_2:
2025-09-13 12:55:38,102 - tweakwcs.wcsimage - INFO - XSH: -2.80118e-05  YSH: -0.00113385
2025-09-13 12:55:38,102 - tweakwcs.wcsimage - INFO - 
2025-09-13 12:55:38,103 - tweakwcs.wcsimage - INFO - FIT RMSE: 0.00327014   FIT MAE: 0.00294319
2025-09-13 12:55:38,103 - tweakwcs.wcsimage - INFO - Final solution based on 221 objects.
2025-09-13 12:55:38,162 - tweakwcs.imalign - INFO -  
2025-09-13 12:55:38,163 - tweakwcs.imalign - INFO - ***** tweakwcs.imalign.align_wcs() ended on 2025-09-13 12:55:38.162712
2025-09-13 12:55:38,163 - tweakwcs.imalign - INFO - ***** tweakwcs.imalign.align_wcs() TOTAL RUN TIME: 0:00:00.954716
2025-09-13 12:55:38,164 - tweakwcs.imalign - INFO -  
2025-09-13 12:55:38,221 - stcal.alignment.util - INFO - Update S_REGION to POLYGON ICRS  274.714143514 -13.874671024 274.732189749 -13.875242929 274.732867747 -13.857857570 274.714788460 -13.857094579
2025-09-13 12:55:38,302 - stcal.alignment.util - INFO - Update S_REGION to POLYGON ICRS  274.714837709 -13.855933735 274.732926140 -13.856599430 274.733740588 -13.839141211 274.715564838 -13.838281445
2025-09-13 12:55:38,331 - py.warnings - WARNING - /usr/share/miniconda/lib/python3.13/site-packages/gwcs/wcs/_wcs.py:1761: UserWarning: Double sampling check FAILED: Sampling may be too coarse for the distortion model being fitted.
  fit_poly_x, fit_poly_y, max_resid = fit_2D_poly(
2025-09-13 12:55:38,352 - stpipe.Image3Pipeline.tweakreg - INFO - Step tweakreg done
2025-09-13 12:55:38,566 - stpipe.Image3Pipeline.skymatch - INFO - Step skymatch running with args (<jwst.datamodels.library.ModelLibrary object at 0x7fcacc1e1130>,).
2025-09-13 12:55:38,677 - stcal.skymatch.skymatch - INFO -  
2025-09-13 12:55:38,677 - stcal.skymatch.skymatch - INFO - ***** stcal.skymatch.skymatch.skymatch() started on 2025-09-13 12:55:38.677123
2025-09-13 12:55:38,678 - stcal.skymatch.skymatch - INFO -  
2025-09-13 12:55:38,679 - stcal.skymatch.skymatch - INFO - Sky computation method: 'match'
2025-09-13 12:55:38,679 - stcal.skymatch.skymatch - INFO - Sky matching direction: DOWN
2025-09-13 12:55:38,679 - stcal.skymatch.skymatch - INFO - Sky subtraction from image data: OFF
2025-09-13 12:55:38,680 - stcal.skymatch.skymatch - INFO -  
2025-09-13 12:55:38,681 - stcal.skymatch.skymatch - INFO - ----  Computing differences in sky values in overlapping regions.
2025-09-13 12:55:39,260 - stcal.skymatch.skymatch - INFO -    *  Group ID=0. Sky background of component images:
2025-09-13 12:55:39,260 - stcal.skymatch.skymatch - INFO -       - Image ID=jw02739001002_02105_00001_nrca2_cal.fits. Sky background: 0.0140722
2025-09-13 12:55:39,261 - stcal.skymatch.skymatch - INFO -       - Image ID=jw02739001002_02105_00001_nrca4_cal.fits. Sky background: 0.0140722
2025-09-13 12:55:39,261 - stcal.skymatch.skymatch - INFO -    *  Group ID=1. Sky background of component images:
2025-09-13 12:55:39,262 - stcal.skymatch.skymatch - INFO -       - Image ID=jw02739001002_02105_00002_nrca2_cal.fits. Sky background: 0
2025-09-13 12:55:39,262 - stcal.skymatch.skymatch - INFO -       - Image ID=jw02739001002_02105_00002_nrca4_cal.fits. Sky background: 0
2025-09-13 12:55:39,263 - stcal.skymatch.skymatch - INFO -  
2025-09-13 12:55:39,263 - stcal.skymatch.skymatch - INFO - ***** stcal.skymatch.skymatch.skymatch() ended on 2025-09-13 12:55:39.263017
2025-09-13 12:55:39,263 - stcal.skymatch.skymatch - INFO - ***** stcal.skymatch.skymatch.skymatch() TOTAL RUN TIME: 0:00:00.585894
2025-09-13 12:55:39,264 - stcal.skymatch.skymatch - INFO -  
2025-09-13 12:55:39,276 - stpipe.Image3Pipeline.skymatch - INFO - Step skymatch done
2025-09-13 12:55:39,479 - stpipe.Image3Pipeline.outlier_detection - INFO - Step outlier_detection running with args (<jwst.datamodels.library.ModelLibrary object at 0x7fcacc1e1130>,).
2025-09-13 12:55:39,479 - stpipe.Image3Pipeline.outlier_detection - INFO - Outlier Detection mode: imaging
2025-09-13 12:55:39,480 - stpipe.Image3Pipeline.outlier_detection - INFO - Outlier Detection asn_id: a3001
2025-09-13 12:55:39,501 - jwst.resample.resample_utils - INFO - Pixel scale ratio (pscale_out/pscale_in): 1.0
2025-09-13 12:55:39,502 - jwst.resample.resample_utils - INFO - Computed output pixel scale: 0.0307760053214915 arcsec.
2025-09-13 12:55:39,515 - stcal.resample.resample - INFO - Output pixel scale: 0.0307760053214915 arcsec.
2025-09-13 12:55:39,515 - stcal.resample.resample - INFO - Driz parameter kernel: square
2025-09-13 12:55:39,516 - stcal.resample.resample - INFO - Driz parameter pixfrac: 1.0
2025-09-13 12:55:39,516 - stcal.resample.resample - INFO - Driz parameter fillval: NAN
2025-09-13 12:55:39,517 - stcal.resample.resample - INFO - Driz parameter weight_type: ivm
2025-09-13 12:55:39,518 - jwst.resample.resample - INFO - 2 exposures to drizzle together
2025-09-13 12:55:41,426 - stcal.resample.resample - INFO - Resampling science and variance data
2025-09-13 12:55:44,272 - stcal.resample.resample - INFO - Resampling science and variance data
2025-09-13 12:55:45,150 - stcal.alignment.util - INFO - Update S_REGION to POLYGON ICRS  274.711006653 -13.874559287 274.732318949 -13.875346718 274.733746020 -13.838894927 274.712437064 -13.838107620
2025-09-13 12:55:45,721 - jwst.resample.resample - INFO - 2 exposures to drizzle together
2025-09-13 12:55:48,264 - stcal.resample.resample - INFO - Resampling science and variance data
2025-09-13 12:55:51,669 - stcal.resample.resample - INFO - Resampling science and variance data
2025-09-13 12:55:52,549 - stcal.alignment.util - INFO - Update S_REGION to POLYGON ICRS  274.711006653 -13.874559287 274.732318949 -13.875346718 274.733746020 -13.838894927 274.712437064 -13.838107620
2025-09-13 12:55:57,940 - stcal.outlier_detection.utils - INFO - Blotting (2048, 2048) <-- (2422, 4267)
2025-09-13 12:55:58,177 - jwst.outlier_detection.utils - INFO - 816 pixels marked as outliers
2025-09-13 12:56:00,227 - stcal.outlier_detection.utils - INFO - Blotting (2048, 2048) <-- (2422, 4267)
2025-09-13 12:56:00,462 - jwst.outlier_detection.utils - INFO - 117 pixels marked as outliers
2025-09-13 12:56:03,086 - stcal.outlier_detection.utils - INFO - Blotting (2048, 2048) <-- (2422, 4267)
2025-09-13 12:56:03,324 - jwst.outlier_detection.utils - INFO - 789 pixels marked as outliers
2025-09-13 12:56:06,001 - stcal.outlier_detection.utils - INFO - Blotting (2048, 2048) <-- (2422, 4267)
2025-09-13 12:56:06,237 - jwst.outlier_detection.utils - INFO - 140 pixels marked as outliers
2025-09-13 12:56:06,440 - stpipe.Image3Pipeline.outlier_detection - INFO - Saved model in ./nrc_im_demo_data/Obs001/stage3/jw02739001002_02105_00001_nrca2_a3001_crf.fits
2025-09-13 12:56:06,613 - stpipe.Image3Pipeline.outlier_detection - INFO - Saved model in ./nrc_im_demo_data/Obs001/stage3/jw02739001002_02105_00001_nrca4_a3001_crf.fits
2025-09-13 12:56:06,796 - stpipe.Image3Pipeline.outlier_detection - INFO - Saved model in ./nrc_im_demo_data/Obs001/stage3/jw02739001002_02105_00002_nrca2_a3001_crf.fits
2025-09-13 12:56:06,977 - stpipe.Image3Pipeline.outlier_detection - INFO - Saved model in ./nrc_im_demo_data/Obs001/stage3/jw02739001002_02105_00002_nrca4_a3001_crf.fits
2025-09-13 12:56:06,978 - stpipe.Image3Pipeline.outlier_detection - INFO - Step outlier_detection done
2025-09-13 12:56:07,200 - stpipe.Image3Pipeline.resample - INFO - Step resample running with args (<jwst.datamodels.library.ModelLibrary object at 0x7fcacc1e1130>,).
2025-09-13 12:56:07,328 - jwst.resample.resample_utils - INFO - Pixel scale ratio (pscale_out/pscale_in): 1.0
2025-09-13 12:56:07,328 - jwst.resample.resample_utils - INFO - Computed output pixel scale: 0.0307760053214915 arcsec.
2025-09-13 12:56:07,342 - stcal.resample.resample - INFO - Output pixel scale: 0.0307760053214915 arcsec.
2025-09-13 12:56:07,342 - stcal.resample.resample - INFO - Driz parameter kernel: square
2025-09-13 12:56:07,343 - stcal.resample.resample - INFO - Driz parameter pixfrac: 1.0
2025-09-13 12:56:07,344 - stcal.resample.resample - INFO - Driz parameter fillval: NAN
2025-09-13 12:56:07,344 - stcal.resample.resample - INFO - Driz parameter weight_type: exptime
2025-09-13 12:56:07,374 - jwst.resample.resample - INFO - Resampling science and variance data
2025-09-13 12:56:09,285 - stcal.resample.resample - INFO - Resampling science and variance data
2025-09-13 12:56:10,151 - stcal.resample.resample - INFO - Drizzling (2048, 2048) --> (2422, 4267)
2025-09-13 12:56:10,981 - stcal.resample.resample - INFO - Drizzling (2048, 2048) --> (2422, 4267)
2025-09-13 12:56:11,816 - stcal.resample.resample - INFO - Drizzling (2048, 2048) --> (2422, 4267)
2025-09-13 12:56:14,984 - stcal.resample.resample - INFO - Resampling science and variance data
2025-09-13 12:56:15,835 - stcal.resample.resample - INFO - Drizzling (2048, 2048) --> (2422, 4267)
2025-09-13 12:56:16,673 - stcal.resample.resample - INFO - Drizzling (2048, 2048) --> (2422, 4267)
2025-09-13 12:56:17,517 - stcal.resample.resample - INFO - Drizzling (2048, 2048) --> (2422, 4267)
2025-09-13 12:56:21,166 - stcal.resample.resample - INFO - Resampling science and variance data
2025-09-13 12:56:22,003 - stcal.resample.resample - INFO - Drizzling (2048, 2048) --> (2422, 4267)
2025-09-13 12:56:22,842 - stcal.resample.resample - INFO - Drizzling (2048, 2048) --> (2422, 4267)
2025-09-13 12:56:23,675 - stcal.resample.resample - INFO - Drizzling (2048, 2048) --> (2422, 4267)
2025-09-13 12:56:27,312 - stcal.resample.resample - INFO - Resampling science and variance data
2025-09-13 12:56:28,160 - stcal.resample.resample - INFO - Drizzling (2048, 2048) --> (2422, 4267)
2025-09-13 12:56:28,998 - stcal.resample.resample - INFO - Drizzling (2048, 2048) --> (2422, 4267)
2025-09-13 12:56:29,835 - stcal.resample.resample - INFO - Drizzling (2048, 2048) --> (2422, 4267)
2025-09-13 12:56:31,348 - stcal.alignment.util - INFO - Update S_REGION to POLYGON ICRS  274.711006653 -13.874559287 274.732318949 -13.875346718 274.733746020 -13.838894927 274.712437064 -13.838107620
2025-09-13 12:56:31,742 - stpipe.Image3Pipeline.resample - INFO - Saved model in ./nrc_im_demo_data/Obs001/stage3/image3_sw_i2d.fits
2025-09-13 12:56:31,743 - stpipe.Image3Pipeline.resample - INFO - Step resample done
2025-09-13 12:56:31,949 - stpipe.Image3Pipeline.source_catalog - INFO - Step source_catalog running with args (<ImageModel(2422, 4267) from image3_sw_i2d.fits>,).
2025-09-13 12:56:31,962 - stpipe.Image3Pipeline.source_catalog - INFO - Using APCORR reference file: /home/runner/crds/references/jwst/nircam/jwst_nircam_apcorr_0004.fits
2025-09-13 12:56:31,964 - stpipe.Image3Pipeline.source_catalog - INFO - Using ABVEGAOFFSET reference file: /home/runner/crds/references/jwst/nircam/jwst_nircam_abvegaoffset_0002.asdf
2025-09-13 12:56:31,964 - jwst.source_catalog.reference_data - INFO - Instrument: NIRCAM
2025-09-13 12:56:31,965 - jwst.source_catalog.reference_data - INFO - Detector: MULTIPLE
2025-09-13 12:56:31,965 - jwst.source_catalog.reference_data - INFO - Filter: F200W
2025-09-13 12:56:31,966 - jwst.source_catalog.reference_data - INFO - Pupil: CLEAR
2025-09-13 12:56:31,966 - jwst.source_catalog.reference_data - INFO - Subarray: FULL
2025-09-13 12:56:32,001 - jwst.source_catalog.reference_data - INFO - AB to Vega magnitude offset 1.68628
2025-09-13 12:56:38,438 - jwst.source_catalog.detection - INFO - Detected 4334 sources
2025-09-13 12:56:41,592 - stpipe.Image3Pipeline.source_catalog - INFO - Wrote source catalog: ./nrc_im_demo_data/Obs001/stage3/image3_sw_cat.ecsv
2025-09-13 12:56:41,730 - stpipe.Image3Pipeline.source_catalog - INFO - Saved model in ./nrc_im_demo_data/Obs001/stage3/image3_sw_segm.fits
2025-09-13 12:56:41,731 - stpipe.Image3Pipeline.source_catalog - INFO - Wrote segmentation map: image3_sw_segm.fits
2025-09-13 12:56:41,735 - stpipe.Image3Pipeline.source_catalog - INFO - Step source_catalog done
2025-09-13 12:56:41,743 - stpipe.Image3Pipeline - INFO - Step Image3Pipeline done
2025-09-13 12:56:41,744 - jwst.stpipe.core - INFO - Results used jwst version: 1.19.1
# Print out the time benchmark
time1 = time.perf_counter()
print(f"Runtime so far: {time1 - time0:0.0f} seconds")
print(f"Runtime for Image3: {time1 - time_image3:0.0f} seconds")
Runtime so far: 544 seconds
Runtime for Image3: 110 seconds

Verify which pipeline steps were run#

# Identify *_i2d file and open as datamodel
if doimage3:
    if do_swimage3:
        sw_i2d_file = os.path.join(image3_dir, f'{sw_product_name}_i2d.fits')
        i2d_sw_model = datamodels.open(sw_i2d_file)
        step_check_model = i2d_sw_model
        
    if do_lwimage3:
        lw_i2d_file = os.path.join(image3_dir, f'{lw_product_name}_i2d.fits')
        i2d_lw_model = datamodels.open(lw_i2d_file)
        step_check_model = i2d_lw_model

    # Check which steps were run. This should be the same regardless of whether
    # a sw or lw file is used.
    step_check_model.meta.cal_step.instance
{'assign_wcs': 'COMPLETE',
 'charge_migration': 'SKIPPED',
 'clean_flicker_noise': 'SKIPPED',
 'dark_sub': 'COMPLETE',
 'dq_init': 'COMPLETE',
 'flat_field': 'COMPLETE',
 'gain_scale': 'SKIPPED',
 'group_scale': 'SKIPPED',
 'ipc': 'SKIPPED',
 'jump': 'COMPLETE',
 'linearity': 'COMPLETE',
 'outlier_detection': 'COMPLETE',
 'persistence': 'SKIPPED',
 'photom': 'COMPLETE',
 'ramp_fit': 'COMPLETE',
 'refpix': 'COMPLETE',
 'resample': 'COMPLETE',
 'saturation': 'COMPLETE',
 'skymatch': 'COMPLETE',
 'superbias': 'COMPLETE',
 'tweakreg': 'COMPLETE'}

Check which reference files were used to calibrate the dataset

if doimage3:
    step_check_model.meta.ref_file.instance
{'area': {'name': 'crds://jwst_nircam_area_0261.fits'},
 'camera': {'name': 'N/A'},
 'collimator': {'name': 'N/A'},
 'crds': {'context_used': 'jwst_1413.pmap', 'sw_version': '13.0.4'},
 'dark': {'name': 'crds://jwst_nircam_dark_0424.fits'},
 'dflat': {'name': 'N/A'},
 'disperser': {'name': 'N/A'},
 'distortion': {'name': 'crds://jwst_nircam_distortion_0277.asdf'},
 'fflat': {'name': 'N/A'},
 'filteroffset': {'name': 'crds://jwst_nircam_filteroffset_0007.asdf'},
 'flat': {'name': 'crds://jwst_nircam_flat_0761.fits'},
 'fore': {'name': 'N/A'},
 'fpa': {'name': 'N/A'},
 'gain': {'name': 'crds://jwst_nircam_gain_0097.fits'},
 'ifufore': {'name': 'N/A'},
 'ifupost': {'name': 'N/A'},
 'ifuslicer': {'name': 'N/A'},
 'linearity': {'name': 'crds://jwst_nircam_linearity_0052.fits'},
 'mask': {'name': 'crds://jwst_nircam_mask_0076.fits'},
 'msa': {'name': 'N/A'},
 'ote': {'name': 'N/A'},
 'photom': {'name': 'crds://jwst_nircam_photom_0157.fits'},
 'readnoise': {'name': 'crds://jwst_nircam_readnoise_0266.fits'},
 'regions': {'name': 'N/A'},
 'saturation': {'name': 'crds://jwst_nircam_saturation_0097.fits'},
 'sflat': {'name': 'N/A'},
 'sirskernel': {'name': 'crds://jwst_nircam_sirskernel_0002.asdf'},
 'specwcs': {'name': 'N/A'},
 'superbias': {'name': 'crds://jwst_nircam_superbias_0220.fits'},
 'wavelengthrange': {'name': 'N/A'}}

8. Visualize the resampled images#

If you specified that the LW and SW outputs should be resampled onto the same pixel grid, you should be able to open the two i2d files and overlay them and see that the sources and pixel grids line up. If there is any misalignment, you may need to adjust tweakreg parameters in the calls to the Image3 pipeline in order to improve the alignment.

Below we use the Imviz tool within the jdaviz package to visualize the images, one filter at a time.

# Create an Imviz instance and set up default viewer for the F200W data
if doimage3 and do_swimage3:
    imviz_sw_i2d = Imviz()
    viewer_sw_i2d = imviz_sw_i2d.default_viewer

    # Read in the science array for our visualization dataset:
    i2d_sw_science = i2d_sw_model.data

    # Load the dataset into Imviz
    imviz_sw_i2d.load_data(i2d_sw_science)

    # Visualize the dataset:
    imviz_sw_i2d.show()

Remember that in this mosaic we have only two detectors: NRC2 and NRC4 (left and right, respectively). The dither is not large enough to cover the gap between the detectors, and so that gap is still visible in the mosaic.

if doimage3 and do_swimage3:
    viewer_sw_i2d.stretch = 'sqrt'
    viewer_sw_i2d.set_colormap('Viridis')
    viewer_sw_i2d.cuts = '95%'
# Create an Imviz instance and set up default viewer for the F444W data
if doimage3 and do_lwimage3:
    imviz_lw_i2d = Imviz()
    viewer_lw_i2d = imviz_lw_i2d.default_viewer

    # Read in the science array for our visualization dataset:
    i2d_lw_science = i2d_lw_model.data

    # Load the dataset into Imviz
    imviz_lw_i2d.load_data(i2d_lw_science)

    # Visualize the dataset:
    imviz_lw_i2d.show()
if doimage3 and do_lwimage3:
    viewer_lw_i2d.stretch = 'sqrt'
    viewer_lw_i2d.set_colormap('Viridis')
    viewer_lw_i2d.cuts = '95%'

Ovelaying the LW and SW images#

Let’s try putting the SW and LW images on top of one another to create a color image. This should work regardless of whether you resampled the two images onto the same pixel grid.

Let’s get the data first

if doimage3 and do_swimage3 and do_lwimage3:
    imviz_color = Imviz()
    viewer_color = imviz_color.default_viewer

    # Load the datasets into Imviz
    imviz_color.load_data(sw_i2d_file, data_label='sw')
    imviz_color.load_data(lw_i2d_file, data_label='lw')

    # Link images by WCS
    imviz_color.link_data(align_by='wcs')

Now define some options to make the picture look nice.

# Set the colors for the two images. 
if doimage3 and do_swimage3 and do_lwimage3:
    plot_options = imviz_color.plugins['Plot Options']
    plot_options.image_color_mode = 'Color'
    img_settings = {'sw': {'image_color': '#61d3e1',
                           #'stretch_vmin': 0,
                           #'stretch_vmax': 4,
                           #'image_opacity': 0.32,
                           #'image_contrast': 0.69,
                           #'image_bias': 0.39
                           },
                    'lw': {'image_color': '#ff767c',
                           #'stretch_vmin': 0,
                           #'stretch_vmax': 16,
                           #'image_opacity': 0.4,
                           #'image_contrast': 0.94,
                           #'image_bias': 0.74
                           }
                    }

Populate the imviz instance with the settings in the cell above and visualize the dataset

# Now populate the imviz instance with the settings in the cell above.
if doimage3 and do_swimage3 and do_lwimage3:
    for layer, settings in img_settings.items():
        plot_options.layer = f'{layer}[DATA]'
        for k, v in settings.items():
            setattr(plot_options, k, v)
# Visualize the dataset
if doimage3 and do_swimage3 and do_lwimage3:
    imviz_color.show()

9. Visualize Detected Sources#

Using the source catalogs created by the Image3 stage of the pipeline, mark the detected sources, using different markers for point sources and extended sources. The source catalogs are saved in image3/image3_sw_cat.ecsv and image3/image3_lw_cat.ecsv. This time, we will provide the i2d filename to the imviz load_data function, rather than just the array of pixel values. This way, imviz will be able to make use of the WCS in the file. This will allow the sources in the source catalog to be accurately marked in the display.

Read in catalog file and identify point/extended sources#

if doimage3:
    if do_swimage3:
        sw_catalog_file = sw_i2d_file.replace('i2d.fits', 'cat.ecsv')
        sw_catalog = Table.read(sw_catalog_file)
    
        # To identify point/extended sources, use the 'is_extended' column in the source catalog
        sw_pt_src, = np.where(~sw_catalog['is_extended'])
        sw_ext_src, = np.where(sw_catalog['is_extended'])
    
        # Define coordinates of point and extended sources
        sw_pt_coord = Table({'coord': [SkyCoord(ra=sw_catalog['sky_centroid'][sw_pt_src].ra,
                                                dec=sw_catalog['sky_centroid'][sw_pt_src].dec)]})
        sw_ext_coord = Table({'coord': [SkyCoord(ra=sw_catalog['sky_centroid'][sw_ext_src].ra,
                                                 dec=sw_catalog['sky_centroid'][sw_ext_src].dec)]})

    if do_lwimage3:
        lw_catalog_file = lw_i2d_file.replace('i2d.fits', 'cat.ecsv')
        lw_catalog = Table.read(lw_catalog_file)

        # To identify point/extended sources, use the 'is_extended' column in the source catalog
        lw_pt_src, = np.where(~lw_catalog['is_extended'])
        lw_ext_src, = np.where(lw_catalog['is_extended'])

        # Define coordinates of point and extended sources
        lw_pt_coord = Table({'coord': [SkyCoord(ra=lw_catalog['sky_centroid'][lw_pt_src].ra,
                                                dec=lw_catalog['sky_centroid'][lw_pt_src].dec)]})
        lw_ext_coord = Table({'coord': [SkyCoord(ra=lw_catalog['sky_centroid'][lw_ext_src].ra,
                                                 dec=lw_catalog['sky_centroid'][lw_ext_src].dec)]})

Mark the extended and point sources on the images#

Display the image with sources indicated by circles. Point sources will be marked by small pink circles and extended sources will be marked by white circles. Looking at the entire mosaic, there are so many sources found that it’s hard to see much of anything. To get a clearer view, try zooming in on various areas using the magnifying glass icon on the banner immediately above the image.

First we visualize the data without the point sources.

# Read in SW i2d file to Imviz
if doimage3 and do_swimage3:
    imviz_sw_cat = Imviz()
    viewer_sw_cat = imviz_sw_cat.default_viewer
    imviz_sw_cat.load_data(sw_i2d_file)

    # Adjust settings for viewer
    viewer_sw_cat.stretch = 'sqrt'
    viewer_sw_cat.set_colormap('Viridis')
    viewer_sw_cat.cuts = '95%'

    imviz_sw_cat.show()

Now we add the point sources

# Add marker for point sources:
if doimage3 and do_swimage3:
    viewer_sw_cat.marker = {'color': 'pink', 'markersize': 50, 'fill': False}

    viewer_sw_cat.add_markers(sw_pt_coord, use_skycoord=True, marker_name='point_sources')

    # Add marker for extended sources:
    viewer_sw_cat.marker = {'color': 'white', 'markersize': 100, 'fill': False}

    viewer_sw_cat.add_markers(sw_ext_coord, use_skycoord=True, marker_name='extended_sources')

We do the same with the LW file. First we visualize the data.

# Repeat using the LW file
if doimage3 and do_lwimage3:
    imviz_lw_cat = Imviz()
    viewer_lw_cat = imviz_lw_cat.default_viewer
    imviz_lw_cat.load_data(lw_i2d_file)

    # Adjust settings for viewer
    viewer_lw_cat.stretch = 'sqrt'
    viewer_lw_cat.set_colormap('Viridis')
    viewer_lw_cat.cuts = '95%'

    imviz_lw_cat.show()

Now we mark the point sources

# Add marker for point sources:
if doimage3 and do_lwimage3:
    viewer_lw_cat.marker = {'color': 'pink', 'markersize': 50, 'fill': False}

    viewer_lw_cat.add_markers(lw_pt_coord, use_skycoord=True, marker_name='point_sources')

    # Add marker for extended sources:
    viewer_lw_cat.marker = {'color': 'white', 'markersize': 100, 'fill': False}

    viewer_lw_cat.add_markers(lw_ext_coord, use_skycoord=True, marker_name='extended_sources')

10. Notes#

  • Note that the strategy presented in this notebook for placing the SW data onto the same pixel grid as the LW data can be applied to data from any two datasets, regardless of filter or channel. By saving the gWCS from the first dataset into an asdf file and providing that file to the Image3 call with the second dataset, the resulting i2d images will be aligned onto the same pixel grid.

  • If you notice poor alignment across tiles within a single i2d image, or between i2d images that you expect to be aligned, try adjusting the parameters in the tweakreg step. With these, you can customize which sources tweakreg identifies and uses for the alignment.


stsci_logo