NAME

hxipipeline - Hitomi HXI reprocessing task

USAGE

hxipipeline indir outdir steminputs entry_stage exit_stage

DESCRIPTION

The hxipipeline task duplicates most of the Hitomi pipeline for HXI (in particular, not the trend data). It allows the user to run all or part of the pipeline processing, and to vary the calibration files and filtering (screening) criteria used. A number of other pipeline processing parameters can also be changed.

HXI Pipeline Stages

The hxipipeline is divided into 2 stages:

  1. Calibration
  2. Data screening
Each stage may be run singly or in combination with the preceding stages. This is controlled by the 'entry_stage' and 'exit_stage' parameters.

HXI Stage 1 consists of the following ordered steps:

  1. Run cams2att
  2. Run hxisgdsff
  3. Run hxisgdpha
  4. Run hxievtid
  5. Run coordevt

The data screening (Stage 2) is identical to that in the production pipeline when default parameters are used. For details on the default screening applied to the HXI events, see:

Default GTI used for screening data are:

The cleaning process occurs twice for HXI. Once to produce cleaned event files, the second to produce pseudo event files.

INPUT

The input to hxipipeline is specified using (at minimum) the 'indir' parameter. This should be specified as the HXI event_uf level sequence directory, e.g.:

hxipipeline indir=/path/to/100039010/hxi/event_uf

Paths to specific hxi housekeeping and satellite data files can be specified using the 'attitude', 'housekeeping', 'extended_housekeeping', 'makefilter', 'orbit', and 'obsgti' parameters. The attitude, orbit, and HXI housekeeping files are required for Stage 1 calibration.

OUTPUT

File names, etc.

The number of output files depends on both pipeline processing stage(s) and the options selected. All output files are written to the directory specified by the 'outdir' parameter. The archive directory structure is NOT reproduced (i.e. all output files are created in a single directory).

The names of files produced are the same as those found in the HEASARC archive. However, the usual ahXXXXXXXXX prefix, where "XXXXXXXXX" is the sequence number, can be replaced by a character string set by the 'stemoutputs' parameter; this defaults to the value set by the 'steminputs' parameter.

PARAMETERS

indir = indir/ [string]
Directory containing the input data. This should be the full, or relative path to the event_uf level sequence directory, e.g.:
/path/to/100039010/hxi/event_uf 

outdir = outdir/ [string]
Output directory used for all output data, as well as the report file. If 'clobber' is set to no, and this directory already exists, the task fails.

CAUTION: If 'clobber' is set to yes, and this directory already exists, this task overwrites files as needed in this directory.

steminputs = ah1001 [string]
Base (stem) for FITS input files (e.g., ah100039010). This string is used as the base file name for finding input files. For example, if 'steminputs=ah100039010', then to find the attitude file, hxipipeline matches the regular expression /ah100039010\.att(\..+)?$/ against all files found under the 'indir' directory.

stemoutputs = ah1001 [string]
Base (stem) output name used for creating output files.

instrument = HXI [string HXI|HXI1|HXI2]
Instrument name.

entry_stage = 1 [integer 1|2]
Entry stage, 1 or 2.

Stage 1: Re-calibrate unfiltered event files.

Stage 2: Start from existing unfiltered event files.

(exit_stage = 2) [integer 1|2]
Exit stage, 1 or 2.

Stage 1: Produces calibrated unfiltered event files.

Stage 2: Produces screened event files.

(hxi_start = 0.0) [double]
Earliest validity time for HXI calibration files.

(hxi_mkflabel = HXISFFA1CAM) [string]
Label to use for HXI MKF GTI creation. For pseudo events, PSE replaces CAM in the label.

(hxi_ehklabel = HXISFFA1CAM) [string]
Label to use for HXI EHK GTI creation. For pseudo events, PSE replaces CAM in the label.

(hxi_evtlabel = HXISFFA1CAM) [string]
Label to use for HXI event screening. For pseudo events, PSE replaces CAM in the label.

(ra = -999.99999) [double]
Right ascension [degrees] of the point to appear in the center of SKY coordinate images. If 'ra' is within the range 0 <= 'ra' <= 360, the value of the parameter is used and is written to the keyword RA_NOM in output files. 'ra' is outside this range, the 'ra' value is read from the event header of the input file, by searching first for the RA_NOM keyword and if found using its value, or if not found, by searching for the RA_PNT keyword and using its value. If neither keyword is found, the called task coordevt exits with an error.

(dec = -999.99999) [double]
Declination [degrees] of the point to appear in the center of SKY coordinate images. If 'dec' is within the range -90 <= 'dec' <= +90, the value of the parameter is used and is written to the keyword DEC_NOM in output files. If 'dec' is outside this range, the 'dec' value is read from the event header of the input file, by searching first for the DEC_NOM keyword and if found using its value, or if not found, by searching for the DEC_PNT keyword and using its value. If neither keyword is found, the called task coordevt exits with an error.

(roll = 0.0) [double]
The roll angle [degrees] about the center of the SKY coordinate system. The roll angle is the angle measured counterclockwise from Celestial North to the positive SKY Y axis.

(hx1_optdetx = -999.99999) [double]
HXI1 optical axis DETX coordinate. If this parameter is set to a value other than the default, the value is used only to set the OPTDETX header keyword.

(hx1_optdety = -999.99999) [double]
HXI1 optical axis DETY coordinate. If this parameter is set to a value other than the default, the value is used only to set the OPTDETY header keyword.

(hx1_optfocx = -999.99999) [double]
HXI1 optical axis FOCX coordinate. If this parameter is set to a value other than the default, the value is used only to set the OPTFOCX header keyword.

(hx1_optfocy = -999.99999) [double]
HXI1 optical axis FOCY coordinate. If this parameter is set to a value other than the default, the value is used only to set the OPTFOCY header keyword.

(hx1_optskyx = -999.99999) [double]
HXI1 optical axis SKYX coordinate. If this parameter is set to a value other than the default, the value is used only to set the OPTSKYX header keyword.

(hx1_optskyy = -999.99999) [double]
HXI1 optical axis SKYY coordinate. If this parameter is set to a value other than the default, the value is used only to set the OPTSKYY header keyword.

(hx2_optdetx = -999.99999) [double]
HXI2 optical axis DETX coordinate. If this parameter is set to a value other than the default, the value is used only to set the OPTDETX header keyword.

(hx2_optdety = -999.99999) [double]
HXI2 optical axis DETY coordinate. If this parameter is set to a value other than the default, the value is used only to set the OPTDETY header keyword.

(hx2_optfocx = -999.99999) [double]
HXI2 optical axis FOCX coordinate. If this parameter is set to a value other than the default, the value is used only to set the OPTFOCX header keyword.

(hx2_optfocy = -999.99999) [double]
HXI2 optical axis FOCY coordinate. If this parameter is set to a value other than the default, the value is used only to set the OPTFOCY header keyword.

(hx2_optskyx = -999.99999) [double]
HXI2 optical axis SKYX coordinate. If this parameter is set to a value other than the default, the value is used only to set the OPTSKYX header keyword.

(hx2_optskyy = -999.99999) [double]
HXI2 optical axis SKYY coordinate. If this parameter is set to a value other than the default, the value is used only to set the OPTSKYY header keyword.

(hx1_ra_pnt = -999.99999) [double]
RA [degrees] of HXI1 pointing. If this parameter is set to a value other than the default, the value is used only to set the RA_PNT header keyword.

(hx1_dec_pnt = -999.99999) [double]
DEC [degrees] of HXI1 pointing. If this parameter is set to a value other than the default, the value is used only to set the DEC_PNT header keyword.

(hx2_ra_pnt = -999.99999) [double]
RA [degrees] of HXI2 pointing. If this parameter is set to a value other than the default, the value is used only to set the RA_PNT header keyword.

(hx2_dec_pnt = -999.99999) [double]
DEC [degrees] of HXI2 pointing. If this parameter is set to a value other than the default, the value is used only to set the DEC_PNT header keyword.

attitude = ah1001.att [string]
Parameter for coordevt: The name of the attitude file used in the conversion to SKY coordinates. If the transformation does not involve SKY coordinates, an attitude file need not be provided. The attitude can be provided as either quaternions or Z-Y-Z Euler angles. The attitude format in the 'attfile' must match the value of the 'attform' parameter.

orbit = ah1001.orb [string]
Parameter for coordevt: The name of a satellite orbit FITS file. This file provides the satellite orbital velocity as a function of time, which is used in calculating the orbital aberration correction. There are two orbit formats supported (VECTOR, e.g. for Swift, and COMPONENT, e.g. for Suzaku). The orbit format in the orbit file must match the value of the 'orbform' parameter. If the orbital aberration correction is not required (i.e. 'orbaberration=no'), an orbit file need not be provided.

(extended_housekeeping = ah1001.ehk) [string]
Parameter for ahgtigen: Extended housekeeping file.

(makefilter = ah1001.mkf) [string]
Parameter for ahgtigen: Makefilter file.

(obsgti = ah1001_gen.gti) [string]
Parameter for ahscreen: Observation GTI file.

(regionfile = NONE) [string NONE|file name]
Parameter for extractor: Input region file.

(hx1teldef = CALDB) [filename CALDB|file name]
Parameter for coordevt, cams2att: Name of HXI1 teldef file. If 'hx1teldef=CALDB', the teldef file is read from the calibration database.

(hx2teldef = CALDB) [filename CALDB|file name]
Parameter for coordevt, cams2att: Name HXI2 teldef file. If 'hx2teldef=CALDB', the teldef file is read from the calibration database.

(remapfile = CALDB) [filename CALDB|file name]
Parameter for hxisgdsff, hxievtid: File describing the remapping of ASIC_ID and READOUT_ID to sequential numbers in the columns ASIC_ID_RMAP and READOUT_ID_RMAP. If the parameter is set to CALDB, it is read from a file in the calibration database.

(gainfile = CALDB) [filename CALDB|file name]
Parameter for hxisgdpha: FITS table describing the gain calibration of PHA for the HXI or SGD camera. The domain of PHA values is divided into intervals, and a set of cubic polynomial coefficients is given for each interval. If the parameter is set to CALDB, it is read from a file in the calibration database.

(badpixfile = CALDB) [filename CALDB|file name]
Parameter for hxisgdpha, hxievtid: File containing the energy threshold defining a real signal for each readout. If the parameter is set to CALDB, the file is read from the calibration database.

(fluorefile = CALDB) [filename CALDB|file name]
Parameter for hxievtid: Calibration file containing the energy ranges of fluorescence electrons in CdTe and Si. If the parameter is set to CALDB, the file is read from the calibration database.

(enecutfile = CALDB) [filename CALDB|file name]
Parameter for hxievtid: Input energy cut file. If the parameter is set to CALDB, the file is read from the calibration database.

(cm1teldef = CALDB) [filename CALDB|file name]
Parameter for cams2att: Name of CAMS1 teldef file. If 'cams1teldef=CALDB', the telescope and instrument specified by keywords in 'infile1' are used to determine the appropriate teldef file from a CALDB query.

(cm2teldef = CALDB) [filename CALDB|file name]
Parameter for cams2att: Name of CAMS2 teldef file. If 'cams2teldef=CALDB', the telescope and instrument specified by keywords in 'infile1' are used to determine the appropriate teldef file from a CALDB query.

(camstempxy = CALDB) [filename CALDB|file name]
Parameter for cams2att: Name of the CAMS temperature compensation file. If 'camstempxy=CALDB', the telescope and instrument specified by keywords in 'infile1' are used to determine the appropriate calibration file from a CALDB query.

(leapsecfile = REFDATA) [filename CALDB|REFDATA|file name]
Parameter for ahgtigen, ahscreen: Input leap second file. If set to CALDB or REFDATA, the file in the calibration database or in the REFDATA area, respectively, is used.

(selectfile = CALDB) [filename CALDB|file name]
Parameter for ahgtigen, ahscreen: Input file with the selection expressions.

(outnsubcol = no) [boolean yes|no]
Parameter for hxisgdpha: Output the PHA_NSUB column. This column is the PHA minus the ASIC common-mode noise (ASIC_CMN column in the SFF).

(datamode = NONE) [string]
Parameter for hxisgdpha: If 'datamode' is not set to NONE (or an empty string), 'datamode' is used in place of the value of the keyword DATAMODE that is in the input event file.

(randomize = yes) [boolean yes|no]
Parameter for hxisgdpha: Allow randomization of fractional part of PHA before calibration.

(rejectbgo = no) [boolean yes|no]
Parameter for hxievtid: If 'rejectbgo=yes', reject events for which BGO trigger occurred. The BGO is the active anticoincidence shield made of bismuth germanium oxide.

(skipreco = no) [boolean yes|no]
Parameter for hxievtid: If 'skipreco' is set to yes, READALL and CALMODE occurrences are not reconstructed.

(outcalfile = NONE) [filename NONE|file name]
Parameter for hxievtid: Name of output file containing the reconstruction information for each occurrence by detector side. This file is used for calibration and not used for science analysis.

(startsys = RAW) [string RAW|FOC]
Parameter for cams2att: Starting coordinate system for transformation computed by det2att2.

(startstep = 1) [integer 1|2|3|4|5]
Parameter for cams2att: Starting step of the calculation done by cams2att. The five steps are documented in the help file for cams2att.

(stopstep = 5) [integer 1|2|3|4|5]
Parameter for cams2att: Ending step of the calculation done by cams2att. The five steps are documented in the help file for cams2att.

(inext = EVENTS) [string]
Parameter for cams2att: Name of event data extension in 'infile1' and 'infile2'.

(outext = CAMS_OFFSETS) [string]
Parameter for cams2att: Name of data extension in the output file from cams2att step 1 (see 'tempcorfile1' and 'tempcorfile2').

(flipsign = no) [boolean yes|no]
Parameter for cams2att: Flip sign of output offsets and angles.

(prefiltfile1 = NONE) [string]
Parameter for cams2att: Name of filtered, temperature-corrected CAMS1 displacement file. This file is written by the ftselect task in cams2att step 2, and it is read by the cams2det task in step 3. If 'startstep=1' or 'startstep=2', specifying NONE causes the file to be given the name tmp_prefiltfile1.fits and to be deleted if 'cleanup=yes'. If 'startstep=3', the value NONE is invalid, and an actual file name must be specified.

(prefiltfile2 = NONE) [string]
Parameter for cams2att: Name of filtered, temperature-corrected CAMS2 displacement file. This file is written by the ftselect task in cams2att step 2, and it is read by the cams2det task in step 3. If 'startstep=1' or 'startstep=2', specifying NONE causes the file to be given the name tmp_prefiltfile2.fits and to be deleted if 'cleanup=yes'. If 'startstep=3', the value NONE is invalid, and an actual file name must be specified.

(filtoffset = NONE) [string]
Parameter for cams2att: Name of intermediate offset file after filtering. This file is written by the ftselect task in cams2att step 4 and read by the det2att2 task in step 5. If 'startstep' is 1, 2, 3, or 4, specifying NONE causes the file to be given the name tmp_filtoffset.fits and to be deleted if 'cleanup=yes'. If 'startstep=5', the value NONE is invalid, and an actual file name must be specified.

(prefiltexpr = DSP_UP==1 && IS_SAMPLING==1) [string]
Parameter for cams2att: Expression used by ftselect to filter the temperature-corrected CAMS data files 'tempcorfile1' and 'tempcorfile2'.

(filtexpr = BAD_UNITS==0) [string]
Parameter for cams2att: Expression used by ftselect to filter 'offsetfile'.

(gtiexpr0 = BAD_UNITS==0) [string]
Parameter for cams2att: Expression used to create GTI for both CAMS units.

(gtiexpr1 = BAD_UNITS==2) [string]
Parameter for cams2att: Expression to create GTI for CAMS1.

(gtiexpr2 = BAD_UNITS==1) [string]
Parameter for cams2att: Expression to create GTI for CAMS2.

(deltaxcol = DELTARAWX) [string]
Parameter for cams2att: Column name for change in x-coordinate in the file 'filtoffset' read by cams2att step 5.

(deltaycol = DELTARAWY) [string]
Parameter for cams2att: Column name for change in y-coordinate in the file 'filtoffset' read by cams2att step 5.

(sincol = SINANGLE) [string]
Parameter for cams2att: Column name for sine of rotation angle in the file 'filtoffset' read by cams2att step 5.

(coscol = COSANGLE) [string]
Parameter for cams2att: Column name for cosine of rotation angle in the file 'filtoffset' read by cams2att step 5.

(coordevt_startsys = LOWEST) [string LOWEST|RAW|ACT|DET|FOC|SKY|HIGHEST]
Parameter for coordevt: Name of the intitial coordinate system for coordinate conversions.

(stopsys = HIGHEST) [string LOWEST|RAW|ACT|DET|FOC|SKY|HIGHEST]
Parameter for coordevt: Name of the final coordinate system for coordinate conversions.

(annaber = no) [string yes|no|invert]
Parameter for coordevt: Apply annual aberration correction.

(followsun = yes) [boolean yes|no]
Parameter for coordevt: Recalculate the Sun position for each event.

(orbaber = no) [string yes|no|invert]
Parameter for coordevt: Apply satellite orbital aberration correction.

(attinterp = LINEAR) [string LINEAR|CONSTANT]
Parameter for coordevt: Sky attitude interpolation method.

(dattinterp = LINEAR) [string LINEAR|CONSTANT]
Parameter for coordevt: Delta attitude interpolation method.

(attdt = 32.0) [double]
Parameter for coordevt: Allowed margin for time extrapolation [s] in 'attfile'.

(dattdt = 0.5) [double]
Parameter for coordevt: Allowed margin for time extrapolation [s] in 'dattfile'.

(chkattgap = no) [boolean yes|no]
Parameter for coordevt: Limit attitude interpolation if gaps are present.

(chkdattgap = yes) [boolean yes|no]
Parameter for coordevt: Limit delta attitude interpolation if gaps are present.

(attext = ATTITUDE) [string]
Parameter for coordevt: Name of the FITS attitude file extension containing satellite attitude data.

(attcol = QPARAM) [string]
Parameter for coordevt: Name of the FITS column containing attitude values as a vector in the 'attext' extension of the attitude table.

(attform = QUAT) [string QUAT|EULER]
Parameter for coordevt: Attitude format.

(orbext = ORBIT) [string]
Parameter for coordevt: Orbit extension name.

(orbcol = VELOCITY) [string]
Parameter for coordevt: Orbital velocity column name.

(orbform = VECTOR) [string VECTOR|COMPONENTS|KEPLERIAN]
Parameter for coordevt: Orbital velocity format.

(coordevt_randomize = TELDEF) [string yes|no|teldef]
Parameter for coordevt: Randomize coordinates when rebinning.

(randsys = TELDEF) [string TELDEF|LOWEST|RAW|ACT|DET|FOC]
Parameter for coordevt: Starting from coordinate system specified by 'randsys' (default specified in RANCOORD keyword in teldef file), coordinate conversions are randomized, up to the highest coordinate system.

(randscalesys = TELDEF) [string]
Parameter for coordevt: Name of the coordinate system to determine the scaling factor for the randomization interval, +/- 0.5 of a pixel in that coordinate system. The default is to get the name from the RAN_SCL keyword in the teldef file.

(infileext = EVENTS) [string]
Parameter for coordevt: Name of the coordevt input file (parameter 'infile' of coordevt; see below) extension containing the event table.

(timecol = TIME) [string]
Parameter for coordevt: Name of the FITS column in the event table containing time values.

(inclfloatcol = no) [boolean yes|no]
Parameter for coordevt: Write non-rounded coordinate columns.

(inclfloatskycol = no) [boolean yes|no]
Parameter for coordevt: Write non-rounded SKY coordinate columns.

(floatcolsuffix = _FLOAT) [string]
Parameter for coordevt: Suffix for non-rounded coordinate columns.

(startwithfloat = no) [boolean yes|no]
Parameter for coordevt: Start with non-rounded 'startsys' coordinates.

(blankcol = yes) [boolean yes|no]
Parameter for coordevt: Assign null values to columns not calculated.

(btnull = 255) [integer]
Parameter for coordevt: TNULL for byte (B) columns.

(itnull = -999) [integer]
Parameter for coordevt: TNULL for short (I) columns.

(jtnull = -999) [integer]
Parameter for coordevt: TNULL for long (J) columns.

(ktnull = -999) [integer]
Parameter for coordevt: TNULL for long (K) columns.

(sbtnull = 255) [integer]
Parameter for coordevt: TNULL for signed byte columns.

(uitnull = -999) [integer]
Parameter for coordevt: TNULL for unsigned short columns.

(ujtnull = -999) [integer]
Parameter for coordevt: TNULL for unsigned long columns.

(occurrenceid = -1) [integer]
Parameter for hxievtid: If greater than zero, only expand this single occurrence.

(seed = 0) [integer]
Parameter for coordevt, cams2att: Random number generator seed; uses system time for 'seed=0'.

(stemreport) [string]
File stem for log and temporary files. If the parameter is not set, the script automatically sets the stem to "hxipipeline_YYYYMMDDTHHMMSS_" and appends log file and temp file names as necessary. Intended to be set by ahpipeline.

(numerrs = 0) [string]
Number of errors from hxipipeline (output).

(cleanup = yes) [boolean yes|no]
Delete temporary files if 'cleanup=yes'.

(clobber = no) [boolean yes|no]
Overwrites the existing output file if set to yes.

(chatter = 2) [integer]
Chatter level for output. Set to 0 to suppress output, or to 1, 2, or 3 for increasing the chatter of the output.

(logfile = !DEFAULT) [string DEFAULT|NONE|file name]
Log file name. If set to DEFAULT, uses the name of the task and, if preceded by "!", overwrites the file if it exists. If set to NONE, no log file is created.

(debug = no) [boolean yes|no]
Diagnostic output is printed to the screen if set to yes.

(history = yes) [boolean yes|no]
Records task parameters in HISTORY.

THE FOLLOWING PARAMETERS ARE SET BY THE SCRIPT INTERNALLY:

CAMS2ATT:

infile1 = cams1_data.fits [filename]
The hxipipeline task looks for a file with an appropriate name. If found, this parameter is set to that file, Otherwise it is set to NONE. It is possible for either the cm1 or cm2 data file to be set to NONE, however the script fails if both 'infile1' and 'infile2' are missing. Name of input FITS file containing the X and Y positions determined by the CAMS1 system. The task does not change this file.

infile2 = cams2_data.fits [filename]
The hxipipeline task looks for a file with an appropriate name. If found, this parameter is set to that file, Otherwise it is set to NONE. It is possible for either the cm1 or cm2 data file to be set to NONE, however the script fails if both 'infile1' and 'infile2' are missing. Name of input FITS file containing the X and Y positions determined by the CAMS2 system. The task does not change this file.

outfile = deltaq.fits [filename]
Name of output file containing the time-dependent delta-attitude quaternions for conversion from the HXI RAW to ACT system. Set to the concation of 'outdir', "/", 'stemoutputs', and "hx1.att" the first time cams2att runs. Set to the concation of 'outdir', "/", 'stemoutputs', and "hx2.att" the second time cams2att runs. The cams2att task creates this file.

(tempcorfile1 = NONE) [string]
Set to the same name as 'infile1', but in the 'outdir' directory the first time cams2att runs. Set to NONE the second time cams2att runs. Name of temperature-corrected CAMS1 displacement file. This file is written by the task ftcalc in Step 1, and it is read by the task ftselect in Step 2. If' startstep=1', then specifying NONE causes the file to be given the name tmp_tempcorfile1.fits and to be deleted if 'cleanup=yes'. If 'startstep=2', the value NONE is invalid and an actual file name must be specified.

(tempcorfile2 = NONE) [string]
Set to the same name as 'infile2', but in the 'outdir' directory the first time cams2att runs. Set to NONE the second time cams2att runs. Name of temperature-corrected CAMS2 displacement file. This file is written by the task ftcalc in Step 1, and it is read by the task ftselect in Step 2. If 'startstep=1', then specifying NONE causes the file to be given the name tmp_tempcorfile2.fits and to be deleted if 'cleanup=yes'. If 'startstep=2', the value NONE is invalid and an actual file name must be specified.

(offsetfile = NONE) [string]
Name of intermediate offset file. Set to the concatenation of 'outdir', "/", 'stemoutputs', and "hx1_cms.fits" the first time cams2att runs. Set to the concatenation of 'outdir', "/", 'stemoutputs', and "hx2_cms.fits" the second time cams2att runs. This file is written by the task cams2det in Step 3 and read by the task ftselect in Step 4. If 'startstep=1, 2, or 3', then specifying NONE causes the file to be given the name tmp_offsetfile.fits and to be deleted if 'cleanup=yes'. If 'startstep=4', the value NONE is invalid and an actual file name must be specified.

(hxiteldef = CALDB) [string]
Set to 'hx1teldef' parameter the first time cams2att runs. Set to 'hx2teldef' parameter the second time cams2att runs.

HXISGDSFF:

infile [filename]
Set based on the unfiltered event files found in the 'indir' directory during initialization. Input first FITS file (FFF) from HXI or SGD.

outfile [filename]
Output second FITS file (SFF). Set to the same name as 'infile', but in the 'outdir' directory.

HXISGDPHA:

infile [filename]
Set based on the unfiltered event files found in the 'indir' directory during initialization and processed through hxisgdsff. Input SFF from HXI or SGD.

outfile [filename]
Output SFF. Set to the same name as 'infile', but in the outdir directory. Output SFF.

HXISGDEXPAND:

infile [filename]
Set based on the unfiltered event files found in the 'indir' directory during initialization and processed through hxisgdsff and hxisgdpha. Input file of event data from an HXI instrument. This is the SFF after PHA calibration by the task hxisgdpha.

outfile [filename]
Set to the same name as 'infile', but in the 'outdir' directory and changing the extension from "_uf.evt" to "exp_ufa.evt". Output event file containing results of event reconstruction.

HXIEVTID:

infile [filename]
Set based on the unfiltered event files found in the 'indir' directory during initialization and processed through hxisgdsff and hxisgdpha. Input file of event data from an HXI instrument. This is the SFF after PHA calibration by the task hxisgdpha.

outfile [filename]
Set to the same name as 'infile', but in the 'outdir' directory and changing the extension from "_uf.evt" to "rec_ufa.evt". Output event file containing results of event reconstruction.

COORDEVT:

infile = events_in.fits [filename]
Set systematically to the elements in an array that is constructed from any unfiltered event files in the input directory. File name and optional extension name or number enclosed in square brackets of the input table that includes the coordinates (usually RAW) to start the first coordinate conversion. The 'infile' is not changed unless the same file is given as the output file.

outfile = events_out.fits [filename]
Name of the output file containing the calculated values of the transformed coordinates. The 'outfile' is created by copying the 'infile' to 'outfile', updating the values in the coordinate columns of the event extension, and updating relevant header keywords. Other contents of 'infile' are preserved in 'outfile'.

teldeffile = CALDB [filename CALDB|file name]
The name of the telescope definition (teldef) calibration data base (CALDB) file, which specifies the coordinate systems and transformation properties. When this parameter is set to CALDB, a teldef file for the telescope and instrument specified by the TELESCOP and INSTRUME keywords, respectively, is used.

(attfile = NONE) [filename]
Set to the hxipipeline attitude parameter (see above).

(dattfile = NONE) [string]
The script reads the instrument name from the header of the uf event file it is processing and uses the appropriate hx1.att or hx2.att file produced by cams2att. The name of or list of the names of the auxiliary (delta) attitude files needed for certain coordinate transformations (e.g., Hitomi HXI RAW-->ACT). If a list of files is needed, it can be entered one per line in a text file, and then 'dattfile' should be set to that text file name prefixed with "@", for example 'dattfile=@dattfiles.txt'. A delta-attitude file must be provided for each coordinate transformation of type SKYATT in the teldef file, with the exception of the transformation to the SKY system. The delta-attitude must be in quaternion format.

(orbfile = NONE) [filename]
Set to the hxipipeline orbit parameter (see above).

AHGTIGEN:

outfile = ahgti.git [filename]
Set to the value of 'hxifile_out' followed by the extension ".gtimkf", when the input file is set to the makefilter file parameter. The extension is ".gtiehk" when the input file is set to the extended_housekeeping file parameter.

(instrume = NONE) [string HXI1|HXI2]
Read from the header of the file being processed.

(label = NONE) [string HXISFFA1CAM|HXISFFA1PSE]
HXISFFA1CAM or HXISFFA1PSE, depending on if the files being generated are "clean" or "pseudo", respectively.

AHSCREEN:

infile [string]
Set systematically to the elements in an array which is constructed from any reconstructed unfiltered event file produced in the calibration stage. If the calibration stage is being skipped, this array is filled from searching the input directory instead.

outfile [filename]
Set to the same name as 'infile', but in the 'outdir' directory and changing the extension from "rec_ufa.evt" to "rec_cl.evt".

(gtifile) [string]
Set as an array of gtifiles with corresponding extensions: POINTING, TEL, MKF, and (where applicable) EHK.

(upkeyword = yes) [boolean yes|no]
Update timing keywords from input file(s) in output file (hardcoded as yes).

(label = NONE) [string HXISFFA1CAM|HXISFFA1PSE]
HXISFFA1CAM or HXISFFA1PSE, depending on if the files being generated are "clean" or "pseudo", respectively.

EXAMPLES

  1. The following command recalibrates (Stage 1) and re-screens (Stage 2) all HXI data for sequence 100039010 that currently resides in the directory /data/100039010/hxi/event_uf, and the output is stored in a directory called /data/100039010_reproc/.
       hxipipeline indir=/data/100039010/hxi/event_uf outdir=/data/100039010_reproc entry_stage=1 exit_stage=2 \
          steminputs=ah100039010 attitude=/data/100039010/auxil/ah100039010/ah100039010.att \
          orbit=/data/100039010/auxil/ah100039010/ah100039010.orb obsgti=/data/100039010/auxil/ah100039010/ah100039010_gen.gti \
          makefilter=/data/100039010/auxil/ah100039010/ah100039010.mkf \
          exended_housekeeping=/data/100039010/auxil/ah100039010/ah100039010.ehk
    
  2. The following command re-screens (Stage 2 only) HXI data for the same data set as in the previous example.
       hxipipeline indir=/data/100039010/hxi/event_uf outdir=/data/100039010_reproc entry_stage=2 exit_stage=2 \
          steminputs=ah100039010 obsgti=/data/100039010/auxil/ah100039010/ah100039010_gen.gti \
          makefilter=/data/100039010/auxil/ah100039010/ah100039010.mkf \
          exended_housekeeping=/data/100039010/auxil/ah100039010/ah100039010.ehk
    

SEE ALSO

ahcalctime, ahpipeline, cams2att, hxisgdsff, hxisgdpha, hxievtid, coordevt, ahfilter, ahgtigen, ahscreen

LAST MODIFIED

November 3, 2023