本文整理汇总了C++中INITSTATUS函数的典型用法代码示例。如果您正苦于以下问题:C++ INITSTATUS函数的具体用法?C++ INITSTATUS怎么用?C++ INITSTATUS使用的例子?那么恭喜您, 这里精选的函数代码示例或许可以为您提供帮助。
在下文中一共展示了INITSTATUS函数的15个代码示例,这些例子默认根据受欢迎程度排序。您可以为喜欢或者感觉有用的代码点赞,您的评价将有助于系统推荐出更棒的C++代码示例。
示例1: LALCleanMultiSFTVect
/**
* Function to clean a sft vector -- calls LALCleanCOMPLEX8SFT repeatedly for each
* sft in vector
*/
void LALCleanMultiSFTVect (LALStatus *status, /**< pointer to LALStatus structure */
MultiSFTVector *multVect, /**< SFTVector to be cleaned */
INT4 width, /**< maximum width to be cleaned -- set sufficiently large if all bins in each line are to be cleaned*/
INT4 window, /**< window size for noise floor estimation in vicinity of a line */
LineNoiseInfo *lineInfo, /**< list of lines */
RandomParams *randPar /**< parameters for generating random noise */)
{
UINT4 k;
INITSTATUS(status);
ATTATCHSTATUSPTR (status);
ASSERT (multVect, status, SFTCLEANH_ENULL, SFTCLEANH_MSGENULL);
ASSERT (multVect->data, status, SFTCLEANH_ENULL, SFTCLEANH_MSGENULL);
ASSERT (multVect->length > 0, status, SFTCLEANH_EVAL, SFTCLEANH_MSGEVAL);
ASSERT (lineInfo, status, SFTCLEANH_ENULL, SFTCLEANH_MSGENULL);
ASSERT (lineInfo->nLines, status, SFTCLEANH_EVAL, SFTCLEANH_MSGEVAL);
ASSERT (lineInfo->lineFreq, status, SFTCLEANH_ENULL, SFTCLEANH_MSGENULL);
ASSERT (lineInfo->leftWing, status, SFTCLEANH_ENULL, SFTCLEANH_MSGENULL);
ASSERT (lineInfo->rightWing, status, SFTCLEANH_ENULL, SFTCLEANH_MSGENULL);
ASSERT (window > 0, status, SFTCLEANH_EVAL, SFTCLEANH_MSGEVAL);
ASSERT (width >= 0, status, SFTCLEANH_EVAL, SFTCLEANH_MSGEVAL);
for ( k = 0; k < multVect->length; k++) {
TRY (LALCleanSFTVector (status->statusPtr, multVect->data[k], width, window, lineInfo, randPar), status);
}
DETATCHSTATUSPTR (status);
/* normal exit */
RETURN (status);
}
示例2: LALCreateDetector
/**
* DEPRECATED.
* \deprecated Use XLALCreateDetector() instead.
*/
void LALCreateDetector( LALStatus *status,
LALDetector *output,
const LALFrDetector *input,
const LALDetectorType type )
{
INITSTATUS(status);
ASSERT( input != NULL, status, LALDETECTORSH_ENULLP,
LALDETECTORSH_MSGENULLP );
ASSERT( output != NULL, status, LALDETECTORSH_ENULLP,
LALDETECTORSH_MSGENULLP );
output = XLALCreateDetector( output, input, type );
if ( ! output )
switch ( XLALClearErrno() )
{
case XLAL_EINVAL:
ABORT( status, LALDETECTORSH_ETYPE, LALDETECTORSH_MSGETYPE );
break;
default:
ABORTXLAL( status );
}
RETURN(status);
}
示例3: LALForwardRealDFT
void LALForwardRealDFT(
LALStatus *status,
COMPLEX8Vector *output,
REAL4Vector *input
)
{
COMPLEX8Vector *a = NULL;
COMPLEX8Vector *b = NULL;
UINT4 n;
UINT4 j;
UINT4 k;
INITSTATUS(status);
ATTATCHSTATUSPTR( status );
n = input->length;
TRY( LALCCreateVector( status->statusPtr, &a, n ), status );
TRY( LALCCreateVector( status->statusPtr, &b, n ), status );
for ( j = 0; j < n; ++j )
a->data[j] = input->data[j];
TRY( LALDFT( status->statusPtr, b, a, -1 ), status );
for ( k = 0; k <= n / 2; ++k )
output->data[k] = b->data[k];
TRY( LALCDestroyVector( status->statusPtr, &a ), status );
TRY( LALCDestroyVector( status->statusPtr, &b ), status );
DETATCHSTATUSPTR( status );
RETURN( status );
}
示例4: LALGetDetectorStates
/**
* \deprecated Use XLALGetDetectorStates() instead
*/
void
LALGetDetectorStates (LALStatus *status, /**< pointer to LALStatus structure */
DetectorStateSeries **DetectorStates, /**< [out] series of DetectorStates */
const LIGOTimeGPSVector *timestamps, /**< array of GPS timestamps t_i */
const LALDetector *detector, /**< detector info */
const EphemerisData *edat, /**< ephemeris file data */
REAL8 tOffset /**< compute detector states at timestamps SHIFTED by tOffset */
)
{
INITSTATUS(status);
ASSERT ( DetectorStates != NULL, status, DETECTORSTATES_ENULL, DETECTORSTATES_MSGENULL);
ASSERT ( *DetectorStates == NULL, status, DETECTORSTATES_ENONULL, DETECTORSTATES_MSGENONULL);
ASSERT ( timestamps, status, DETECTORSTATES_ENULL, DETECTORSTATES_MSGENULL);
ASSERT ( detector, status, DETECTORSTATES_ENULL, DETECTORSTATES_MSGENULL);
ASSERT ( edat, status, DETECTORSTATES_ENULL, DETECTORSTATES_MSGENULL);
/* call XLAL function */
DetectorStateSeries *ret = NULL;
if ( ( ret = XLALGetDetectorStates ( timestamps, detector, edat, tOffset )) == NULL ) {
XLALPrintError ("%s: XLALGetDetectorStates() failed with code=%d\n", __func__, xlalErrno );
ABORT ( status, DETECTORSTATES_EXLAL, DETECTORSTATES_MSGEXLAL );
}
/* return result */
(*DetectorStates) = ret;
RETURN (status);
} /* LALGetDetectorStates() */
示例5: LALStringToU8
void
LALStringToU8(LALStatus * stat, UINT8 * value, const CHAR * string,
CHAR ** endptr)
{
UINT8 absValue; /* magnitude of parsed number */
INT2 sign; /* sign of parsed number */
CHAR *end; /* substring following parsed number */
INITSTATUS(stat);
/* Check for valid input arguments. */
ASSERT(value, stat, STRINGINPUTH_ENUL, STRINGINPUTH_MSGENUL);
ASSERT(string, stat, STRINGINPUTH_ENUL, STRINGINPUTH_MSGENUL);
/* Parse string. Return if nothing was parsed. */
absValue = LALStringToU8AndSign(&sign, string, &end);
if (string == end) {
if (endptr)
*endptr = end;
RETURN(stat);
}
/* Set values and return. */
*value = absValue;
if (endptr)
*endptr = end;
RETURN(stat);
}
示例6: LALAstroOmega
void LALAstroOmega (LALStatus *s, REAL8 *omeganu, REAL8 nu, void *p)
{
DIntegrateIn zint;
AstroOmegaParams params;
AstroOmegaSourceParams sourcep;
AstroOmegaCosmoParams cosmop;
REAL8 omegaz, zmax, numax, lambda;
INITSTATUS(s);
ATTATCHSTATUSPTR (s);
params = *((AstroOmegaParams *)p);
cosmop=params.cosmoparams;
sourcep = params.sourceparams;
numax= sourcep.numax;
lambda = sourcep.lambda;
if((nu >= numax)||(nu <= 0.)){*omeganu = 0.;}
else
{
if (nu < (numax / 6.)) {zmax = 5.;}
else {zmax = (numax / nu) - 1.;}
zint.function = dAstroOmega;
zint.xmin = 0;
zint.xmax = zmax;
zint.type = ClosedInterval;
LALDRombergIntegrate (s->statusPtr, &omegaz, &zint, ¶ms);
*omeganu = 4.66e-56 * lambda / (cosmop.ho * cosmop.ho) * nu * omegaz;
}
CHECKSTATUSPTR (s);
DETATCHSTATUSPTR (s);
RETURN (s);
}
示例7: LALDriveNRInject
/** Main driver funtion for doing Numerical Relativity Injections */
void LALDriveNRInject( LALStatus *status, /**< pointer to LALStatus structure */
REAL4TimeSeries *injData, /**< The time series to inject into */
SimInspiralTable *injections, /**< The list of injections to perform */
NumRelInjectParams *params /**< Parameters */
)
{
REAL4TimeVectorSeries *sumStrain = NULL;
SimInspiralTable *thisInj = NULL; /* current injection */
INITSTATUS(status);
ATTATCHSTATUSPTR (status);
/* loop over injections */
for ( thisInj = injections; thisInj; thisInj = thisInj->next )
{
TRY( LALAddStrainModes(status->statusPtr, &sumStrain, params->nrCatalog,
params->modeLlo, params->modeLhi, thisInj), status);
TRY( LALInjectStrainGW( status->statusPtr, injData, sumStrain, thisInj, params->ifo, params->dynRange), status);
XLALDestroyREAL4VectorSequence ( sumStrain->data );
LALFree( sumStrain );
sumStrain = NULL;
} /* end loop over injections */
DETATCHSTATUSPTR(status);
RETURN(status);
}
示例8: LALBinaryPulsarDeltaT
/**
* Calculate the binary system time delay using the pulsar parameters in
* \c params
*/
void
LALBinaryPulsarDeltaT( LALStatus *status,
BinaryPulsarOutput *output,
BinaryPulsarInput *input,
BinaryPulsarParams *params ){
INITSTATUS(status);
ATTATCHSTATUSPTR(status);
/* Check input arguments */
ASSERT(input != (BinaryPulsarInput *)NULL, status,
BINARYPULSARTIMINGH_ENULLINPUT, BINARYPULSARTIMINGH_MSGENULLINPUT);
ASSERT(output != (BinaryPulsarOutput *)NULL, status,
BINARYPULSARTIMINGH_ENULLOUTPUT, BINARYPULSARTIMINGH_MSGENULLOUTPUT);
ASSERT(params != (BinaryPulsarParams *)NULL, status,
BINARYPULSARTIMINGH_ENULLPARAMS, BINARYPULSARTIMINGH_MSGENULLPARAMS);
ASSERT((!strcmp(params->model, "BT")) ||
(!strcmp(params->model, "BT1P")) ||
(!strcmp(params->model, "BT2P")) ||
(!strcmp(params->model, "BTX")) ||
(!strcmp(params->model, "ELL1")) ||
(!strcmp(params->model, "DD")) ||
(!strcmp(params->model, "DDS")) ||
(!strcmp(params->model, "MSS")) ||
(!strcmp(params->model, "T2")), status,
BINARYPULSARTIMINGH_ENULLBINARYMODEL,
BINARYPULSARTIMINGH_MSGNULLBINARYMODEL);
XLALBinaryPulsarDeltaT( output, input, params );
DETATCHSTATUSPTR(status);
RETURN(status);
}
示例9: LALTimeFreqComplexFFT
void
LALTimeFreqComplexFFT(
LALStatus *status,
COMPLEX8FrequencySeries *freq,
COMPLEX8TimeSeries *time,
ComplexFFTPlan *plan
)
{
INITSTATUS(status);
XLAL_PRINT_DEPRECATION_WARNING("XLALCOMPLEX8TimeFreqFFT");
ASSERT( plan, status, TIMEFREQFFTH_ENULL, TIMEFREQFFTH_MSGENULL );
ASSERT( freq, status, TIMEFREQFFTH_ENULL, TIMEFREQFFTH_MSGENULL );
ASSERT( time, status, TIMEFREQFFTH_ENULL, TIMEFREQFFTH_MSGENULL );
ASSERT( time->data, status, TIMEFREQFFTH_ENULL, TIMEFREQFFTH_MSGENULL );
ASSERT( time->data->length, status, TIMEFREQFFTH_ESIZE, TIMEFREQFFTH_MSGESIZE );
ASSERT( time->deltaT > 0, status, TIMEFREQFFTH_ERATE, TIMEFREQFFTH_MSGERATE );
ASSERT( plan->sign == -1, status, TIMEFREQFFTH_ESIGN, TIMEFREQFFTH_MSGESIGN );
if ( XLALCOMPLEX8TimeFreqFFT( freq, time, plan ) == XLAL_FAILURE )
{
XLALClearErrno();
ABORTXLAL( status );
}
RETURN( status );
}
示例10: LALSelectPeakWhiteNoise
void LALSelectPeakWhiteNoise(LALStatus *status,
UCHARPeakGram *pg,
REAL8 *thr,
REAL8Periodogram1 *peri)
{
INT4 length;
INT4 nPeaks;
/* --------------------------------------------- */
INITSTATUS(status);
ATTATCHSTATUSPTR (status);
/* Make sure the arguments are not NULL: */
ASSERT (peri, status, PEAKSELECTH_ENULL, PEAKSELECTH_MSGENULL);
ASSERT (pg, status, PEAKSELECTH_ENULL, PEAKSELECTH_MSGENULL);
ASSERT (thr, status, PEAKSELECTH_ENULL, PEAKSELECTH_MSGENULL);
pg->epoch.gpsSeconds = peri->epoch.gpsSeconds;
pg->epoch.gpsNanoSeconds = peri->epoch.gpsNanoSeconds;
pg->timeBase = peri->timeBase;
pg->fminBinIndex = peri->fminBinIndex;
length = peri->length;
nPeaks = 0;
ASSERT (length==pg->length, status, PEAKSELECTH_EVAL, PEAKSELECTH_MSGEVAL);
if (length > 0){
UCHAR *out;
REAL8 *in1;
REAL8 threshold;
INT4 n;
ASSERT (peri->data, status, PEAKSELECTH_ENULL, PEAKSELECTH_MSGENULL);
ASSERT (pg->data, status, PEAKSELECTH_ENULL, PEAKSELECTH_MSGENULL);
out = pg->data;
in1 = peri->data;
threshold = *thr;
n = length;
while (n-- >0){
if ( *in1 > threshold){
*out = 1 ;
nPeaks++ ;
} else {
*out = 0;
}
++out;
++in1;
}
}
pg->nPeaks = nPeaks;
DETATCHSTATUSPTR (status);
/* normal exit */
RETURN (status);
}
示例11: LALDSymmetricEigenValues
/** \see See \ref Eigen_c for documentation */
void
LALDSymmetricEigenValues( LALStatus *stat, REAL8Vector *values, REAL8Array *matrix )
{
REAL8Vector *offDiag = NULL; /* off-diagonal line of
tri-diagonalized matrix */
INITSTATUS(stat);
ATTATCHSTATUSPTR( stat );
/* Check dimension length. All other argument testing is done by
the subroutines. */
ASSERT( values, stat, MATRIXUTILSH_ENUL, MATRIXUTILSH_MSGENUL );
ASSERT( values->length, stat, MATRIXUTILSH_ENUL, MATRIXUTILSH_MSGENUL );
/* Allocate an off-diagonal vector for the tri-diagonal matrix. */
TRY( LALDCreateVector( stat->statusPtr, &offDiag, values->length ),
stat );
/* Call the subroutines. */
LALDSymmetricToTriDiagonal2( stat->statusPtr, values, matrix,
offDiag );
BEGINFAIL( stat ) {
TRY( LALDDestroyVector( stat->statusPtr, &offDiag ), stat );
} ENDFAIL( stat );
LALDTriDiagonalToDiagonal2( stat->statusPtr, values, matrix,
offDiag );
BEGINFAIL( stat ) {
TRY( LALDDestroyVector( stat->statusPtr, &offDiag ), stat );
} ENDFAIL( stat );
/* Clean up. */
TRY( LALDDestroyVector( stat->statusPtr, &offDiag ), stat );
DETATCHSTATUSPTR( stat );
RETURN( stat );
}
示例12: LALVersion
/**
* \ingroup LALVersion_h
* Routine that returns the version of LAL.
* This function writes a version message into the string buffer of specified
* size (and is truncated if the buffer is too small). Configuration information
* is also provided if the verbose flag is set.
*
*/
void
LALVersion(LALStatus * status, CHAR * message, UINT4 size, INT4 verbose)
{
INT4 nchar;
INITSTATUS(status);
ASSERT(message, status, LALVERSIONH_ENULL, LALVERSIONH_MSGENULL);
ASSERT(size > 0, status, LALVERSIONH_ESIZE, LALVERSIONH_MSGESIZE);
nchar = verbose ?
snprintf(message, size,
"LAL Version: %s\n"
"Git ID: %s\n"
"Git Tag: %s\n"
"Build Date: %s\n"
"Configure Date: %s\n"
"Configure Arguments: %s\n",
lalVersion, lalHeaderVCSInfo.vcsId,
lalHeaderVCSInfo.vcsTag, lalBuildDate, lalConfigureDate,
lalConfigureArgs) : snprintf(message, size,
"LAL Version: %s\n",
lalVersion);
if (nchar < 0) {
ABORT(status, LALVERSIONH_ESPRN, LALVERSIONH_MSGESPRN);
}
if (nchar > (INT4) size) {
ABORT(status, LALVERSIONH_ESHRT, LALVERSIONH_MSGESHRT);
}
RETURN(status);
}
示例13: InitUserVars
/**
* register all our "user-variables"
*/
void
InitUserVars (LALStatus *status, struct CommandLineArgsTag *CLA)
{
INITSTATUS(status);
ATTATCHSTATUSPTR (status);
/* Initialize default values */
CLA->Tsft=1800;
CLA->nTsft=0;
CLA->timestamps=NULL;
CLA->gpsStart=-1;
CLA->sqrtSh=1.0;
/** Default year-span of ephemeris-files to be used */
CLA->ephemEarth = XLALStringDuplicate("earth00-19-DE405.dat.gz");
CLA->ephemSun = XLALStringDuplicate("sun00-19-DE405.dat.gz");
/* ---------- register all our user-variable ---------- */
XLAL_CHECK_LAL( status, XLALRegisterNamedUvar(&(CLA->Alpha), "Alpha", REAL8, 'a', OPTIONAL, "Sky position Alpha (equatorial coordinates) in radians") == XLAL_SUCCESS, XLAL_EFUNC);
XLAL_CHECK_LAL( status, XLALRegisterNamedUvar(&(CLA->Alpha), "longitude", REAL8, 0, DEVELOPER, "[DEPRECATED] Use --Alpha instead!") == XLAL_SUCCESS, XLAL_EFUNC);
XLAL_CHECK_LAL( status, XLALRegisterNamedUvar(&(CLA->Delta), "Delta", REAL8, 'd', OPTIONAL, "Sky position Delta (equatorial coordinates) in radians") == XLAL_SUCCESS, XLAL_EFUNC);
XLAL_CHECK_LAL( status, XLALRegisterNamedUvar(&(CLA->Delta), "latitude", REAL8, 0, DEVELOPER, "[DEPRECATED] Use --Delta instead!") == XLAL_SUCCESS, XLAL_EFUNC);
XLAL_CHECK_LAL( status, XLALRegisterNamedUvar(&(CLA->phi0), "phi0", REAL8, 'Q', OPTIONAL, "Phi_0: Initial phase in radians") == XLAL_SUCCESS, XLAL_EFUNC);
XLAL_CHECK_LAL( status, XLALRegisterNamedUvar(&(CLA->psi), "psi", REAL8, 'Y', OPTIONAL, "Polarisation in radians") == XLAL_SUCCESS, XLAL_EFUNC);
XLAL_CHECK_LAL( status, XLALRegisterNamedUvar(&(CLA->cosi), "cosi", REAL8, 'i', OPTIONAL, "Cos(iota)") == XLAL_SUCCESS, XLAL_EFUNC);
XLAL_CHECK_LAL( status, XLALRegisterNamedUvar(&(CLA->cosiota), "cosiota", REAL8, 0, DEVELOPER, "[DEPRECATED] Use --cosi instead") == XLAL_SUCCESS, XLAL_EFUNC);
XLAL_CHECK_LAL( status, XLALRegisterNamedUvar(&(CLA->h0), "h0", REAL8, 's', OPTIONAL, "Strain amplitude h_0") == XLAL_SUCCESS, XLAL_EFUNC);
XLAL_CHECK_LAL( status, XLALRegisterNamedUvar(&(CLA->sqrtSh), "sqrtSh", REAL8, 'N', OPTIONAL, "Noise floor: one-sided sqrt(Sh) in 1/sqrt(Hz)") == XLAL_SUCCESS, XLAL_EFUNC);
XLAL_CHECK_LAL( status, XLALRegisterNamedUvar(&(CLA->timestamps), "timestampsFile", STRING, 'T', OPTIONAL, "Name of timestamps file") == XLAL_SUCCESS, XLAL_EFUNC);
XLAL_CHECK_LAL( status, XLALRegisterNamedUvar(&(CLA->gpsStart), "startTime", INT4, 'S', OPTIONAL, "GPS start time of continuous observation") == XLAL_SUCCESS, XLAL_EFUNC);
XLAL_CHECK_LAL( status, XLALRegisterNamedUvar(&(CLA->Tsft), "Tsft", REAL8, 't', OPTIONAL, "Length of an SFT in seconds") == XLAL_SUCCESS, XLAL_EFUNC);
XLAL_CHECK_LAL( status, XLALRegisterNamedUvar(&(CLA->nTsft), "nTsft", INT4, 'n', OPTIONAL, "Number of SFTs") == XLAL_SUCCESS, XLAL_EFUNC);
XLAL_CHECK_LAL( status, XLALRegisterNamedUvar(&(CLA->IFO), "IFO", STRING, 'D', OPTIONAL, "Detector: H1, H2, L1, G1, ... ") == XLAL_SUCCESS, XLAL_EFUNC);
XLAL_CHECK_LAL( status, XLALRegisterNamedUvar(&(CLA->detector), "detector", STRING, 0, DEVELOPER, "[DEPRECATED] Use --IFO instead!") == XLAL_SUCCESS, XLAL_EFUNC);
XLAL_CHECK_LAL( status, XLALRegisterNamedUvar(&(CLA->ephemEarth), "ephemEarth", STRING, 0, OPTIONAL, "Earth ephemeris file to use") == XLAL_SUCCESS, XLAL_EFUNC);
XLAL_CHECK_LAL( status, XLALRegisterNamedUvar(&(CLA->ephemSun), "ephemSun", STRING, 0, OPTIONAL, "Sun ephemeris file to use") == XLAL_SUCCESS, XLAL_EFUNC);
/* ----- added for mfd_v4 compatibility ---------- */
XLAL_CHECK_LAL ( status, XLALRegisterNamedUvar(&(CLA->duration), "duration", REAL8, 0, OPTIONAL, "Duration of requested signal in seconds") == XLAL_SUCCESS, XLAL_EFUNC);
XLAL_CHECK_LAL ( status, XLALRegisterNamedUvar(&(CLA->aPlus), "aPlus", REAL8, 0, OPTIONAL, "Plus polarization amplitude aPlus") == XLAL_SUCCESS, XLAL_EFUNC);
XLAL_CHECK_LAL ( status, XLALRegisterNamedUvar(&(CLA->aCross), "aCross", REAL8, 0, OPTIONAL, "Cross polarization amplitude aCross") == XLAL_SUCCESS, XLAL_EFUNC);
DETATCHSTATUSPTR (status);
RETURN(status);
} /* InitUserVars() */
示例14: FreqDiff
/* A function to compute the difference between the current and
requested normalized frequency, used by the root bisector. */
static void
FreqDiff( LALStatus *stat, REAL4 *y, REAL4 x, void *p )
{
FreqDiffParamStruc *par; /* *p cast to its proper type */
REAL4 c0, c1, c2, c3, c4, c5; /* PN frequency coefficients */
BOOLEAN b0, b1, b2, b3, b4, b5; /* whether each order is nonzero */
REAL4 x2, x3, x4, x5; /* x^2, x^3, x^4, and x^5 */
INITSTATUS(stat);
ASSERT( p, stat, 1, "Null pointer" );
/* Set constants used by FREQ() macro. */
par = (FreqDiffParamStruc *)( p );
c0 = par->c[0];
c1 = par->c[1];
c2 = par->c[2];
c3 = par->c[3];
c4 = par->c[4];
c5 = par->c[5];
b0 = par->b[0];
b1 = par->b[1];
b2 = par->b[2];
b3 = par->b[3];
b4 = par->b[4];
b5 = par->b[5];
/* Evaluate frequency and compare with reference. */
FREQ( *y, x );
*y -= par->y0;
RETURN( stat );
}
示例15: LALDestroyUserVars
/** \deprecated us XLALDestroyUserVars() instead */
void
LALDestroyUserVars (LALStatus *status)
{
INITSTATUS(status);
XLALDestroyUserVars();
RETURN (status);
} // LALDestroyUserVars()