[Next]
NAME: Accum
PURPOSE: Accumulate average spectra over a series of time intervals
CATEGORY: Spectral analysis
CALLING SEQUENCE:
accum, select = iselect, ltime=ltime, in_obs=obs, in_eobs=eobs, in_back=back, in_eback=eback, $ ;inputs
live=live, obsi=obsi, eobsi=eobsi, backi=backi, ebacki=ebacki, convi=convi
INPUTS:
in_obs - series of spectra, nchan x nbin
in_eobs- gaussian uncertainties on obs
ltime- livetime of each interval
in_back- background spectrum for each interval, also, nchanxnbin (optional)
in_eback - uncertainties on back (optional)
select - 2 x nsel pairs of indices referenced to obs for summing spectra
OUTPUTS:
obsi - time averaged spectra - float(nchan x n_elements(iselect(0,*)))
eobsi- uncertainties on obsi
backi- time averaged background spectra
ebacki
live - summed livetime for each new interval - float( nchan x n_elements(iselect(0,*)))
convi- conversion factors - count-rate flux / photon flux - float(nchan x n_elements(iselect(0,*)))
CALLS: ***
F_DIV
CALLED BY:
SPEX_COMMONS [2], SPEX_COMMONS [4], SPEX_PROC [1], SPEX_PROC [2]
PROCEDURE: spectra are live time averaged and uncertainties are sqrt of sum of squared
uncertainties, background uncertainty is invariant with summing
MODIFICATION HISTORY: ras, 12-feb-94
ras, 24-oct-94,
ras, 9-dec-1996, reconciled with change in iselect
[Previous]
[Next]
NAME: Accum
PURPOSE: Accumulate average spectra over a series of time intervals
CATEGORY: Spectral analysis
CALLING SEQUENCE:
accum, select = iselect, ltime=ltime, in_obs=obs, in_eobs=eobs, in_back=back, in_eback=eback, $ ;inputs
live=live, obsi=obsi, eobsi=eobsi, backi=backi, ebacki=ebacki, convi=convi
INPUTS:
in_obs - series of spectra, nchan x nbin
in_eobs- gaussian uncertainties on obs
ltime- livetime of each interval
in_back- background spectrum for each interval, also, nchanxnbin (optional)
in_eback - uncertainties on back (optional)
select - 2 x nsel pairs of indices referenced to obs for summing spectra
OUTPUTS:
obsi - time averaged spectra - float(nchan x n_elements(iselect(0,*)))
eobsi- uncertainties on obsi
backi- time averaged background spectra
ebacki
live - summed livetime for each new interval - float( nchan x n_elements(iselect(0,*)))
convi- conversion factors - count-rate flux / photon flux - float(nchan x n_elements(iselect(0,*)))
CALLS: ***
F_DIV
CALLED BY:
SPEX_COMMONS [2], SPEX_COMMONS [4], SPEX_PROC [1], SPEX_PROC [2]
PROCEDURE: spectra are live time averaged and uncertainties are sqrt of sum of squared
uncertainties, background uncertainty is invariant with summing
MODIFICATION HISTORY: ras, 12-feb-94
ras, 24-oct-94,
ras, 9-dec-1996, reconciled with change in iselect
[Previous]
[Next]
NAME:
adrlb
PURPOSE
ANDRIL ENGINE
CALLING SEQUENCE:
adrlb,iter,psf,data,decon,unc,dark,mode,n,t,div,absthr,chithr,$
likenew,imax,jmax,imagp,ww,thr,afac,dimpsf,dime,w,calc,b
adrlb,iter,psf,data,decon,unc,dark,mode,n,t,div,absthr,chithr,$
likenew,imax,jmax,imagp,ww,thr,afac,dimpsf,dime,w,calc,b,/SILENT
INPUTS:
B is the PEDESTAL Factor
Caution some of the inputs are redundant in order to speed-up
calculations
iter is the present iteration step varied in the outer loop
psf is the externally supplied PSF
data is the supplied image to be deconvolved (in Photons - Poisonian)
unc is the supplied uncertainty array (in Photons)
decon is the first approximation/result of the iteration (usually flat)
mode is the mode (0 for classical, 1 for accelerated)
N, T are the parameters regulating the U - smoothing (3,0.2)
div is the superresolution factor (usually 5)
absthr is the average absolute deviation for pixeles above threshold
chithr is the normalised chi^2 value for pixels above threshold
likenew is the natural Log of likelihood
imax,jmax are externally supplied maximum dimensions for the weight corrections
ratp is the externally supplied array of ratios observed/calculated signal
ww is the correction factor array used to improve old model (decon)
wthr is the externally supplied vector of pixels selected above threshold
afac is the external optional factor allowing to scale the calculation aplitude (set to 1)
dimpsf is the dimension of the PSF expressed in SXT pixels
dime is the dimension of square data array
w is the array of weights calculated externally by diwalim1
calc is the calculated signal in pixels
OPTIONAL INPUT KEYWORDS:
SILENT - doesn't show the windows for the plots: U-Function, Correction matrix, abs(obs-cal)/unc,
ratio observed/calculated and deconvolved image
METHOD:
Calculates only a single iteration so outer loop necessary
Image restoration Using the Damped
Richardson-Lucy Method, in The restoration of HST Image and Spectra II,
Space Telecsope Science institute, 1994
R.J. Hanisch and R.L.White eds, 104-110
gives possibility of classic or accelerated calculations
uses inputs expressed in photons
uses Varosi convolution procedure
CALLS: ***
CONVOLVE, calctst, chisq, nlikely, parabola, positivi, ufun
CALLED BY:
DRLB Version 30
HISTORY:
written, Janusz Sylwester, Space Research Centre, Polish Acad.
of Sciences 1996 - 1999
Oct 98, inserted option for b - pedestal factor
[Previous]
[Next]
NAME:
Ai_bpow
PURPOSE:
the inital values of apar, the fit parameters,
for the broken power law..
CALLING SEQUENCE:
apar=Ai_bpow(fy,sfy,e)
INPUT:
fy=Log(Photon Flux),
sfy=Unc. in fy squared,
e=log(channel energies),
OUTPUT:
apar=initial values for the fit parameters
CALLS: ***
CHECKVAR [1], checkvar [2], lfit_2 [1], lfit_2 [2]
CALLED BY:
Ai_vth_bpow [1], Ai_vth_bpow [2]
HISTORY:
16-nov-95, from ai_2pl.pro, jmm
[Previous]
[Next]
NAME:
Ai_bpow
PURPOSE:
the inital values of apar, the fit parameters,
for the broken power law..
CALLING SEQUENCE:
apar=Ai_bpow(fy,sfy,e)
INPUT:
fy=Log(Photon Flux),
sfy=Unc. in fy squared,
e=log(channel energies),
OUTPUT:
apar=initial values for the fit parameters
CALLS: ***
CHECKVAR [1], checkvar [2], lfit_2 [1], lfit_2 [2]
CALLED BY:
Ai_vth_bpow [1], Ai_vth_bpow [2]
HISTORY:
16-nov-95, from ai_2pl.pro, jmm
[Previous]
[Next]
NAME:
Ai_thermal
PURPOSE:
the inital values of a for the single thermal..
CALLING SEQUENCE:
a=Ai_thermal(fy,sfy,e,nch)
INPUT:
fy=Log(Photon Flux),
sfy=Unc. in fy squared,
e=log(channel energies),
nch=no. of channels
OUTPUT:
a=initial values for a, the fit parameters
CALLS: ***
CHECKVAR [1], checkvar [2]
CALLED BY:
Ai_vth_bpow [1], Ai_vth_bpow [2]
HISTORY:
16-nov-95, from ai_1th.pro, jmm
[Previous]
[Next]
NAME:
Ai_thermal
PURPOSE:
the inital values of a for the single thermal..
CALLING SEQUENCE:
a=Ai_thermal(fy,sfy,e,nch)
INPUT:
fy=Log(Photon Flux),
sfy=Unc. in fy squared,
e=log(channel energies),
nch=no. of channels
OUTPUT:
a=initial values for a, the fit parameters
CALLS: ***
CHECKVAR [1], checkvar [2]
CALLED BY:
Ai_vth_bpow [1], Ai_vth_bpow [2]
HISTORY:
16-nov-95, from ai_1th.pro, jmm
[Previous]
[Next]
NAME:
Ai_vth_bpow
PURPOSE:
the inital values of a for the thermal + double P.L..
CALLING SEQUENCE:
a=Ai_vth_bpow(fy,sfy,e)
INPUT:
fy=Log(Photon Flux),
sfy=Unc. in fy squared,
e=log(channel energies),
OUTPUT:
a=initial values for a, the fit parameters
CALLS: ***
Ai_bpow [1], Ai_bpow [2], Ai_thermal [1], Ai_thermal [2], CHECKVAR [1], F_BPOW
Lfit_3 [1], Lfit_3 [2], checkvar [2]
HISTORY:
16-nov-95, from ai_thppl.pro, jmm
[Previous]
[Next]
NAME:
Ai_vth_bpow
PURPOSE:
the inital values of a for the thermal + double P.L..
CALLING SEQUENCE:
a=Ai_vth_bpow(fy,sfy,e)
INPUT:
fy=Log(Photon Flux),
sfy=Unc. in fy squared,
e=log(channel energies),
OUTPUT:
a=initial values for a, the fit parameters
CALLS: ***
Ai_bpow [1], Ai_bpow [2], Ai_thermal [1], Ai_thermal [2], CHECKVAR [1], F_BPOW
Lfit_3 [1], Lfit_3 [2], checkvar [2]
HISTORY:
16-nov-95, from ai_thppl.pro, jmm
[Previous]
[Next]
NAME:
allpks_html
PURPOSE:
To create single html files that contain all the individual peak
plots for file infile (or all files found)
CALLING SEQUENCE:
allpks_html,infile=infile
CALLS: ***
BREAK_FILE [1], BREAK_FILE [2], BREAK_FILE [3], break_file [4], file_list [1]
file_list [2]
HISTORY:
Written 4-Mar-97 S.Qwan
24-Nov-98 TDT infile option, new web paths
[Previous]
[Next]
NAME:
ampex_restore
PURPOSE:
A front end into the "ampex_restore.sh" shell script to allow a user
to select and restore a dataset from the ampex tape drives
SAMPLE CALLING SEQUENCE:
.run ampex_restore
HISTORY:
Written 14-Feb-96 by M.Morrison
6-May-96 (MDM) - Added "-batch" switch to ampex_restore.sh call
18-Jun-96 (MDM) - Added sorting of the directories by subdirectory
12-Jul-96 (MDM) - Modified to use XMENU_SEL
- Do a "qwmenu=1" before running if want to use wmenu_sel
1-Aug-96 (MDM) - Truncated the directory (to avoid window crash)
28-Aug-96 (MDM) - Added showing how much disk space the restore will take
- Added option to create a control file to restore the data
11-Sep-97 (MDM) - Modified to work with TRACE
21-Jan-98 (MDM) - Modified to shorten the menu listing so that the
full directory can be read
[Previous]
[Next]
NAME:
ANDRIL_SXT
Version 3.1 11 May, 1999
PURPOSE
SXT interface to ANDRIL which directly corresponds to those described in the
Main routine; sets-up deconvolution of SXT images
from full-resolution data.
CALLING SEQUENCE:
andril_SXT, nfil, x0 , y0 , cimage, dimage, decon
andril_SXT, nfil, x0 , y0 , cimage, dimage, decon,MODE=mode,NITER=niter,N=n,T=t,B=b,DIMPSF=dimpsf,DIV=div,THR=thr,/SILENT=silent
andril_sxt, 4 , 452, 496, data_be(*,*,0), dark_be(*,*,0),decon
andril_sxt, 4 , 452, 496, data_be(*,*,0), dark_be(*,*,0),decon,niter=10,/SILENT
INPUTS:
nfil - is the filter number for the image according to convention
1: OPTICAL'
2: THIN ALUMINUM Al 01
3: AlMg dagwood
4: Be 119
5: Al 12
6: Mg 03
x0,y0 - are the coordinates of the lower left corner of the SXT image to be deconvolved
(as obtained from gt_corner(index) fi. 816,448 for region close to the western limb)
cimage - compressed SXT image as coming from .yodat spr* file reformatting MUST be square array
dimage - corresponding dark current & other corrections combined array
etime - exposure time in s used to normalize the image to rates/subpixel
timek - time of the frame "k" in decimak hours
stimek - string of time for frame "k" in hh:mm:ss
datek - string of date for frame "k" in dd-mmm-yy
framek - frame # "k"
OUTPUTS:
decon - deconvolved image
KEYWORDS:
MODE - is the version: 0 for classical Richardson-Lucy (RL),
1 for accelerated RL
NITER - is the termination step for the iteration
N,T - are the parameters regulating the U - smoothing (cf. N=3, T=0.2)
B - is the pedestal background ( b =~10 ) which damps the noise
DIMPSF - is the size of the PSF array as expressed in SXT 7, for 7x7 PSF window size
DIV - is the superresolution factor (usually 5)
THR - Signal/Noise threshold used for detecting significant pixels
used for calculations of normalized Chi^2 (usulally 5)
SILENT - doesn't show the windows for the plots: U-Function, Correction matrix, abs(obs-cal)/unc,
ratio observed/calculated and deconvolved image
METHOD:
PAPERS:
ANDRIL - Maximum Likelihood Algorithm for Deconvolution of SXT Images
J. S y l w e s t e r and B. S y l w e s t e r
ACTA ASTRONOMICA vol. 48 (1998)pp. 519-545
and
Reconstruction of Images with Poisson Noise
J. S y l w e s t e r and B. S y l w e s t e r
ACTA ASTRONOMICA (1999) - submitted
CALLS: ***
CONCAT_DIR [1], CONCAT_DIR [2], CONCAT_DIR [3], CONVOLVE, FILE_EXIST [2], SXT_DECO
concat_dir [4], curdir [1], curdir [2], file_exist [1], file_exist [3]
get_logenv [1], get_logenv [2], positivi, rl_decob, sxt_comp, sxt_psd
HISTORY:
written J. Sylwester, 1996 - May 1999
S.L.Freeland 13-December-2000 - file names relative to $SSWDB_ANDRIL
[Previous]
[Next]
NAME: apar_check
PURPOSE: reconcile array of parameters with initial values for parameters and number of
intervals
CATEGORY: spectral analysis
CALLING SEQUENCE: apar_check, apar, nint, apar_arr [, force=force], apar_last=apar_last
CALLED BY: SPEX
INPUTS:
apar - default starting parameters, 1-d vector, npar elements
nint - number of spectral intervals
/force - if set then all intervals are loaded with apar
OUTPUTS:
apar_arr - fltarr( npar, nint)
apar_last- fltarr( npar, nint)
CALLS: ***
CHECKVAR [1], checkvar [2]
CALLED BY:
SPEX_COMMONS [2], SPEX_COMMONS [4], SPEX_PROC [1], SPEX_PROC [2]
PROCEDURE: If apar_arr (and apar_last) is (are) not consistent in number with n_elements(apar)
and nint (number of intervals), then it is made consistent, if it is consistent
then it is unchanged unless /force is used.
MODIFICATION HISTORY: 14-feb-94
[Previous]
[Next]
NAME: apar_check
PURPOSE: reconcile array of parameters with initial values for parameters and number of
intervals
CATEGORY: spectral analysis
CALLING SEQUENCE: apar_check, apar, nint, apar_arr [, force=force], apar_last=apar_last
CALLED BY: SPEX
INPUTS:
apar - default starting parameters, 1-d vector, npar elements
nint - number of spectral intervals
/force - if set then all intervals are loaded with apar
OUTPUTS:
apar_arr - fltarr( npar, nint)
apar_last- fltarr( npar, nint)
CALLS: ***
CHECKVAR [1], checkvar [2]
CALLED BY:
SPEX_COMMONS [2], SPEX_COMMONS [4], SPEX_PROC [1], SPEX_PROC [2]
PROCEDURE: If apar_arr (and apar_last) is (are) not consistent in number with n_elements(apar)
and nint (number of intervals), then it is made consistent, if it is consistent
then it is unchanged unless /force is used.
MODIFICATION HISTORY: 14-feb-94
[Previous]
[Next]
NAME:
Apar_init
PURPOSE:
Obtain initial values for apar; the spectral fit parameters
CALLING SEQUENCE:
apar=Apar_init(e_out, counts, sigma, e_in, w_in, drm)
INPUT:
f_model = Spectral model used, e.g. power law or thermal brem.
e.g., 'f_bpow', 'f_vth_bpow'
e_out = 2xN output energy bins, ie, for the channels
counts = observed count rate, N numbers in the channels given by e_out
sigma = sigma(counts)
e_in = 2xM input energy bins
w_in = Width of input energy bins.
drm = Detector response matrix dimensioned n x m where n is the number
of output energy bins and m is the number of input energy bins.
OUTPUT:
apar=initial values of a, the fit parameters
CALLS: ***
CHECKVAR [1], checkvar [2], get_conversion [1], get_conversion [2]
HISTORY:
16-nov-95, from AINIT.pro, jmm
[Previous]
[Next]
NAME:
Apar_init
PURPOSE:
Obtain initial values for apar; the spectral fit parameters
CALLING SEQUENCE:
apar=Apar_init(e_out, counts, sigma, e_in, w_in, drm)
INPUT:
f_model = Spectral model used, e.g. power law or thermal brem.
e.g., 'f_bpow', 'f_vth_bpow'
e_out = 2xN output energy bins, ie, for the channels
counts = observed count rate, N numbers in the channels given by e_out
sigma = sigma(counts)
e_in = 2xM input energy bins
w_in = Width of input energy bins.
drm = Detector response matrix dimensioned n x m where n is the number
of output energy bins and m is the number of input energy bins.
OUTPUT:
apar=initial values of a, the fit parameters
CALLS: ***
CHECKVAR [1], checkvar [2], get_conversion [1], get_conversion [2]
HISTORY:
16-nov-95, from AINIT.pro, jmm
[Previous]
[Next]
PROJECT: CHIANTI
CHIANTI is an Atomic Database Package for Spectroscopic Diagnostics of
Astrophysical Plasmas. It is a collaborative project involving the Naval
Research Laboratory (USA), the University of Florence (Italy), the
University of Cambridge and the Rutherford Appleton Laboratory (UK).
NAME:
ASCII_WVL_DEM
PURPOSE:
create an ascii file of predicted spectral line intensities and
wavelengths corresponding to a selected abundance and differential
emission measure (DEM).
PROCEDURE:
Calculations are done assuming either constant density or
constant pressure. See CH_SYNTHETIC for details.
CALLING SEQUENCE:
ASCII_WVL_DEM, Wmin, Wmax, Pressure= , [density= ], $
[outfile= , mini= , sngl_ion=, /photons, /all, /masterlist], $
[/noprot, radtemp=, rphot=]
INPUTS:
Wmin: lower limit of the wavelength range of interest (Angstroms)
if kev keyword set, then wmin is in kev
Wmax: upper limit of the wavelength range of interest (Angstroms)
if kev keyword set, then wmax is in kev
Pressure: pressure in emitting region (cm^-3 K), or
Density: density in emitting region (cm^-3).
OPTIONAL INPUTS:
OUTFILE: the name of the output ascii file to be written.
MINI: Minimum intensity for a line to be included in the output.
SNGL_ION: specifies a single ion (e.g. SNGL_ION='Fe_10' to include
only Fe X lines) or an array (e.g. SNGL_ION=['Fe_10','Fe_11']
to include only Fe X and Fe XI lines) of ions to be used
instead of the complete set of ions specified in
!xuvtop/masterlist/masterlist.ions
MASTERLIST: string of a specific masterlist file (full path).
If defined as a keyword (i.e. MASTERLIST=1 or /MASTERLIST)
then a widget allows the user to select a user-defined
masterlist file. Shortcut for SNGL_ION.
OUTPUTS:
an ascii file: linelist.txt in the working directory by default
OPTIONAL OUTPUTS:
KEYWORD PARAMETERS:
MINI: Minimum intensity for a line to be included in the output
SNGL_ION: specifies a single ion (e.g. SNGL_ION='Fe_10' to include
only Fe X lines) or an array (e.g. SNGL_ION=['Fe_10','Fe_11']
to include only Fe X and Fe XI lines) of ions to be used
instead of the complete set of ions specified in
!xuvtop/masterlist/masterlist.ions
MASTERLIST: string of a specific masterlist file (full path).
If defined as a keyword (i.e. MASTERLIST=1 or /MASTERLIST)
then a widget allows the user to select a user-defined
masterlist file. Shortcut for SNGL_ION.
PHOTONS: units will be in photons rather than ergs
KEV: wavelengths will be given in kev rather than Angstroms
ALL: if set, then all lines are included. This means that lines
for which
only an approximate wavelength is known (only theoretical energy
levels are known) are included.
OUTFILE: the name of the output ascii file to be written. By
default a
file 'linelist.txt' in the user's working directory will be
created.
NOPROT If set, then the default setting will be NOT to use
proton rates. This can be changed within the routine.
RADTEMP Specify background radiation temperature (default: 6000 K)
RPHOT Distance from the centre of the star in stellar radius units.
I.e., RPHOT=1 corresponds to the star's surface. (Default is
infinity, i.e., no photoexcitation.)
CALLS: ***
CH_LINE_LIST, CH_SYNTHETIC
COMMON BLOCKS: None
RESTRICTIONS:
SIDE EFFECTS:
EXAMPLE:
IDL> ascii_wvl_dem,400.,800., out='linelist',$
pressure=1.e+15,mini=1.,sngl_ion='o_4'
CATEGORY:
spectral synthesis.
WRITTEN :
Version 1, 8-Nov-01, Giulio Del Zanna (GDZ).
Compared to the previous ASCII_WVL_DEM, these are the main changes:
1-Rewritten as a wrapper routine using the new procedures.
2-Now the PRESSURE value is a keyword.
3-The calculations can be done at constant DENSITY.
4-Energies (keV) can be output instead of wavelengths in Angstroms
5-MASTERLIST can now be used both as an input string or as a keyword.
MODIFICATION HISTORY:
18-Nov-01, Peter Young
Added /noprot, rphot and radtemp keywords
V. 2, 22-May-2002 GDZ. Removed const_net definitions.
VERSION : 2, 22-May-2002
[Previous]
[Next]
Project : SDAC
Name : ATMOS
Purpose : This function returns the X-ray cross-sections for the Earth's
atmosphere in units of cm2/gm
Category : XRAY, UTIL
Explanation : Using the accepted concentrations of Nitrogen, Oxygen, and Argon
together with the cross-sections available through xsec.pro, the cross-section
is computed vs energy from 1.00001 to 999.999 keV.
Use : cross_section = Atmos( Energy )
Inputs : Energy - scalar or vector in units of keV. 1.00001 to 999.999 keV.
Opt. Inputs : Numberfrac - Array of three numbers totaling 1 for the relative
percent compositon by weight of N, O, and Ar.
Outputs : Returns the cross-section in units of cm2/gm.
Opt. Outputs: None
Keywords : Type - A string with values 'PE'-photoelectric, 'SI'-Compton scattering,
'SC'- elastic scattering. See xsec.pro for more details.
Calls : ***
CHECKVAR [1], COEFDATA, checkvar [2], xsec
CALLED BY:
OCC_PROFILE
Common : None
Restrictions:
Side effects: None.
Prev. Hist : Written, RAS, ~1988
Modified : Version 2, Revised for SSW, RAS, richard.schwartz@gsfc.nasa.gov, 20-jul-1997.
[Previous]
[Next]
NAME:
av_dt_genx
PURPOSE:
To average a set of detune GENX data results
SAMPLE CALLING SEQUENCE:
dtav = av_dt_genx(dt)
dtav = av_dt_genx(dt, good=[0,1,3,4])
INPUT:
dt = array of structures of GENX detune results
CALLS: ***
savegen [1], savegen [2], sum_dt_genx
OPTIONAL KEYWORD INPUT:
good = array of indices of good elements of dt
outfil = filename for saving the result
OUTPUT:
A structure of the same form as dt containing the averages
Prints a short summary of the average detune
HISTORY:
Written 30-Dec-97 by T. Tarbell
Ver 1.1 2-Jan-98 (TDT) - Use weighted averages for results
Ver 1.11 27-Mar-00 (TDT)- added sum_dt_genx,dt for printed summary
[Previous]
[Next]
PROJECT:
YOHKOH
CATEGORY:
HXT, INSTRUMENT
NAME:
AVE_CTS2
PURPOSE:
This function returns the counts/sec/subcollimator value from given data(....,64,....).
Note that 'data' should be in unit of cts / 0.5 sec for each sensor
(should be decompressed from 8 to 12 bit beforehand).
N.B. data should not be decompressed when use CALIBRATION data
These data are stored into 8 bit counters only so are transmitted
without compression.
CALLING SEQUENCE:
hxt_rate = ave_cts2( index, data, time=time $
[,sf=sf] [,ser=ser] [,dt=dt]
INPUTS:
index - index returned by yodat for hda file
data - data array returned by yodat corresponding to index
OPTIONAL INPUTS:
sf - average over the frames
ser - serial, return with hxt_rate = fltarr(4,4*n_index)
time = fltarr(4*n_index)
datarectypes - if this value is 2, then these are calibration data
which is 64 channels x 64 detectors every 8 seconds
uses only the first value whether array or not
so let caller beware.
OUTPUTS:
hxt_rate - hxt cnt rate in each energy bin per second per
subcollimator
returned as fltarr(4,4,n_index) where n_index is
the number of elements in index
OPTIONAL OUTPUTS:
time - time in seconds relative to the time given by index(0)
time is centered within the accumulation interval
dt - accumulation time for each sample
iout64- index structure for 64 channel hxt data
dout64- data records for 64 channel hxt data (intarr(64, 64, n)
CALLED BY:
HXT_CAL_FIX [1], HXT_CAL_FIX [2], read_yohkoh_4_spex [1]
read_yohkoh_4_spex [2]
PROCEDURE: data is extracted and converted in groups of 64 major
frames to avoid page fault delays
CALLS: ***
FCHECK, F_DIV, HXT_PRESTORE [1], HXT_PRESTORE [2], HXT_PRESTORE [3]
HXT_PRESTORE [4], HXT_PRESTORE [5], HX_DECOMP, RESTORE_OVERFLOW, dprate2sec [1]
dprate2sec [2], gt_dp_mode [1], gt_dp_mode [2], mk_timarr [1], mk_timarr [2]
reform_hxtcal2
RESTRICTIONS:
MODIFICATION HISTORY:
19-apr-94 R.Schwartz, adopted from ave_cts.pro
eradicated do loops and added documentation
21-jun-94, ras, replace div with f_div
22-jun-94, ras, changed mk_timarr
01-jul-94, ras, fixed bug induced from dprate2sec not returning a vector
for a single element
16-jan-1996, ras, add calibration data format
31-jan-1996, ras, added calibration data overflow correction, dout64, iout64
2-may-1996, ras, fixed error in subscripting non-existent dtypes
8-jan-1996, ras, prestore==>hxt_prestore
15-jan-1996, ras, protect use of dtype
9-feb-1997, ras, switch to hx_decomp from hxt_decomp, use the McTiernan version
CONTACT:
richard.schwartz@gsfc.nasa.gov
[Previous]
[Next]
PROJECT:
YOHKOH
CATEGORY:
HXT, INSTRUMENT
NAME:
AVE_CTS2
PURPOSE:
This function returns the counts/sec/subcollimator value from given data(....,64,....).
Note that 'data' should be in unit of cts / 0.5 sec for each sensor
(should be decompressed from 8 to 12 bit beforehand).
N.B. data should not be decompressed when use CALIBRATION data
These data are stored into 8 bit counters only so are transmitted
without compression.
CALLING SEQUENCE:
hxt_rate = ave_cts2( index, data, time=time $
[,sf=sf] [,ser=ser] [,dt=dt]
INPUTS:
index - index returned by yodat for hda file
data - data array returned by yodat corresponding to index
OPTIONAL INPUTS:
sf - average over the frames
ser - serial, return with hxt_rate = fltarr(4,4*n_index)
time = fltarr(4*n_index)
datarectypes - if this value is 2, then these are calibration data
which is 64 channels x 64 detectors every 8 seconds
uses only the first value whether array or not
so let caller beware.
OUTPUTS:
hxt_rate - hxt cnt rate in each energy bin per second per
subcollimator
returned as fltarr(4,4,n_index) where n_index is
the number of elements in index
OPTIONAL OUTPUTS:
time - time in seconds relative to the time given by index(0)
time is centered within the accumulation interval
dt - accumulation time for each sample
iout64- index structure for 64 channel hxt data
dout64- data records for 64 channel hxt data (intarr(64, 64, n)
CALLED BY:
HXT_CAL_FIX [1], HXT_CAL_FIX [2], read_yohkoh_4_spex [1]
read_yohkoh_4_spex [2]
PROCEDURE: data is extracted and converted in groups of 64 major
frames to avoid page fault delays
CALLS: ***
FCHECK, F_DIV, HXT_PRESTORE [1], HXT_PRESTORE [2], HXT_PRESTORE [3]
HXT_PRESTORE [4], HXT_PRESTORE [5], HX_DECOMP, RESTORE_OVERFLOW, dprate2sec [1]
dprate2sec [2], gt_dp_mode [1], gt_dp_mode [2], mk_timarr [1], mk_timarr [2]
reform_hxtcal2
RESTRICTIONS:
MODIFICATION HISTORY:
19-apr-94 R.Schwartz, adopted from ave_cts.pro
eradicated do loops and added documentation
21-jun-94, ras, replace div with f_div
22-jun-94, ras, changed mk_timarr
01-jul-94, ras, fixed bug induced from dprate2sec not returning a vector
for a single element
16-jan-1996, ras, add calibration data format
31-jan-1996, ras, added calibration data overflow correction, dout64, iout64
2-may-1996, ras, fixed error in subscripting non-existent dtypes
8-jan-1996, ras, prestore==>hxt_prestore
15-jan-1996, ras, protect use of dtype
9-feb-1997, ras, switch to hx_decomp from hxt_decomp, use the McTiernan version
CONTACT:
richard.schwartz@gsfc.nasa.gov
[Previous]
[Next]
pro awbinchk, fn
Checks Arbitrarily weighted binned data
CALLS: