Page MenuHomeHEPForge

No OneTemporary

This file is larger than 256 KB, so syntax highlighting was skipped.
Index: trunk/npstat/interfaces/MinuitNeymanOSDE1DFcn.hh
===================================================================
--- trunk/npstat/interfaces/MinuitNeymanOSDE1DFcn.hh (revision 896)
+++ trunk/npstat/interfaces/MinuitNeymanOSDE1DFcn.hh (revision 897)
@@ -1,92 +1,108 @@
#ifndef NPSI_MINUITNEYMANOSDEFCN_HH_
#define NPSI_MINUITNEYMANOSDEFCN_HH_
/*!
// \file MinuitNeymanOSDE1DFcn.hh
//
// \brief Minuit function to minimize for Neyman OSDE
//
// Author: I. Volobouev
//
// March 2023
*/
+#include <cassert>
+
#include "Minuit2/FCNGradientBase.h"
#include "npstat/stat/NeymanOSDE1D.hh"
namespace npsi {
/**
// Target minimization function adapter class for running Neyman OSDE
- // fits by Minuit2. All shrinkages will be automatically set to 1.
+ // fits by Minuit2. Note that NeymanOSDE1D object is not copied,
+ // only a reference is held, with the corresponding consequences
+ // for the object lifetimes.
*/
class MinuitNeymanOSDE1DFcn : public ROOT::Minuit2::FCNGradientBase
{
public:
inline MinuitNeymanOSDE1DFcn(
- const npstat::NeymanOSDE1D& i_osde, const double up=0.1)
- : osde_(i_osde), up_(up), lastResult_(-1.0) {}
+ const npstat::NeymanOSDE1D& i_osde,
+ const unsigned nCoeffsExpected,
+ const double* shrinkages, const unsigned nShrinkages,
+ const double up=0.1)
+ : osde_(i_osde),
+ shrinkages_(shrinkages, shrinkages+nShrinkages),
+ lastGradient_(nCoeffsExpected),
+ polyStatistics_(nShrinkages),
+ lastResult_(-1.0),
+ up_(up),
+ nCoeffs_(nCoeffsExpected)
+ {
+ assert(nCoeffs_);
+ assert(nShrinkages);
+ assert(shrinkages);
+ }
inline virtual ~MinuitNeymanOSDE1DFcn() {}
inline const npstat::NeymanOSDE1D& getOsde() const {return osde_;}
// Make Minuit look for a better minimum by reducing
// the recommended "Up" value by an order of magnitude
inline double Up() const {return up_;}
// Do not waste time checking gradient calculations. They are correct.
inline bool CheckGradient() const {return false;}
inline virtual double operator()(const std::vector<double>& x) const
{
calculateMemoized(x);
return lastResult_;
}
inline std::vector<double> Gradient(const std::vector<double>& x) const
{
// Returning std::vector<double> on the stack is
// a pretty inefficient thing to do. However,
// this is how Minuit2 interface is designed.
calculateMemoized(x);
return lastGradient_;
}
private:
MinuitNeymanOSDE1DFcn();
// Minuit2 has separate interfaces for calculating the function
// value and the gradient. I have yet to see a non-trivial realistic
// problem in which the function value can not be easily obtained
// along with the gradient. It would be much better to have them
// calculated together. We will alleviate this design problem
// by memoizing the argument / result pairs so that we do not
// have to repeat the calculation when the gradient is wanted
// at the same point where the function was just evaluated.
inline void calculateMemoized(const std::vector<double>& x) const
{
if (x != lastX_ || lastResult_ < 0.0)
{
- const unsigned nCoeffs = x.size();
- assert(nCoeffs);
- const unsigned nShrinkages = 2U*nCoeffs;
- std::vector<double> shrinkages(nShrinkages, 1.0);
- std::vector<double> polyStatistics(nShrinkages);
- if (lastGradient_.size() != nCoeffs)
- lastGradient_.resize(nCoeffs);
+ assert(x.size() == nCoeffs_);
lastResult_ = osde_.chiSquare(
- &x[0], nCoeffs, &shrinkages[0], nShrinkages,
- &polyStatistics[0], &lastGradient_[0]);
+ &x[0], nCoeffs_,
+ &shrinkages_[0], shrinkages_.size(),
+ &polyStatistics_[0], &lastGradient_[0]);
lastX_ = x;
}
}
- npstat::NeymanOSDE1D osde_;
- double up_;
+ const npstat::NeymanOSDE1D& osde_;
+ std::vector<double> shrinkages_;
mutable std::vector<double> lastX_;
mutable std::vector<double> lastGradient_;
+ mutable std::vector<double> polyStatistics_;
mutable double lastResult_;
+ double up_;
+ unsigned nCoeffs_;
};
}
#endif // NPSI_MINUITNEYMANOSDEFCN_HH_
Index: trunk/npstat/stat/NeymanOSDE1DResult.cc
===================================================================
--- trunk/npstat/stat/NeymanOSDE1DResult.cc (revision 0)
+++ trunk/npstat/stat/NeymanOSDE1DResult.cc (revision 897)
@@ -0,0 +1,22 @@
+#include <stdexcept>
+
+#include "npstat/stat/NeymanOSDE1DResult.hh"
+
+namespace npstat {
+ const char* neymanOSDEMinimizerName(const unsigned code)
+ {
+ static const char* names[NOSDE_N_MINIMIZER_CODES] = {
+ "Unoptimized",
+ "Newton",
+ "Gradient Descent",
+ "Random Search",
+ "Minuit",
+ "Minuit Improved",
+ "Other"
+ };
+
+ if (code >= NOSDE_N_MINIMIZER_CODES) throw std::invalid_argument(
+ "In npstat::neymanOSDEMinimizerName: minimizer code is out of range");
+ return names[code];
+ }
+}
Index: trunk/npstat/stat/NeymanOSDE1DResult.hh
===================================================================
--- trunk/npstat/stat/NeymanOSDE1DResult.hh (revision 896)
+++ trunk/npstat/stat/NeymanOSDE1DResult.hh (revision 897)
@@ -1,64 +1,77 @@
#ifndef NPSTAT_NEYMANOSDE1DRESULT_HH_
#define NPSTAT_NEYMANOSDE1DRESULT_HH_
#include <vector>
namespace npstat {
+ enum NeymanOSDE1DMinimizerCode {
+ NOSDE_NOT_OPTIMIZED = 0,
+ NOSDE_NEWTON,
+ NOSDE_GRADIENT_DESCENT,
+ NOSDE_RANDOM_SEARCH,
+ NOSDE_MINUIT,
+ NOSDE_MINUIT_IMPROVED,
+ NOSDE_OTHER,
+ NOSDE_N_MINIMIZER_CODES
+ };
+
+ const char* neymanOSDEMinimizerName(unsigned minimizerCode);
+
class NeymanOSDE1DResult
{
public:
inline NeymanOSDE1DResult(const std::vector<double>& i_coeffs,
const std::vector<double>& polyStats,
const double i_chiSquare,
const double i_maxAbsGradient,
const unsigned i_minimizerCode,
const unsigned i_nIterations,
const bool i_converged,
const bool i_badHessian)
: coeffs_(i_coeffs),
polyStatistics_(polyStats),
chiSquare_(i_chiSquare),
maxAbsGradient_(i_maxAbsGradient),
minimizerCode_(i_minimizerCode),
nIterations_(i_nIterations),
converged_(i_converged),
badHessian_(i_badHessian)
{
}
inline void setMinimizerCode(const unsigned c) {minimizerCode_ = c;}
inline const std::vector<double>& coeffs() const {return coeffs_;}
inline const std::vector<double>& polyStatistics() const
{return polyStatistics_;}
inline double chiSquare() const {return chiSquare_;}
inline double maxAbsGradient() const {return maxAbsGradient_;}
inline unsigned minimizerCode() const {return minimizerCode_;}
inline unsigned nIterations() const {return nIterations_;}
inline bool converged() const {return converged_;}
inline bool badHessian() const {return badHessian_;}
inline bool operator<(const NeymanOSDE1DResult& r) const
{
if (chiSquare_ < r.chiSquare_) return true;
if (r.chiSquare_ < chiSquare_) return false;
if (maxAbsGradient_ < r.maxAbsGradient_) return true;
if (r.maxAbsGradient_ < maxAbsGradient_) return false;
if (converged_ && !r.converged_) return true;
if (!converged_ && r.converged_) return false;
return false;
}
private:
std::vector<double> coeffs_;
std::vector<double> polyStatistics_;
double chiSquare_;
double maxAbsGradient_;
unsigned minimizerCode_;
unsigned nIterations_;
bool converged_;
bool badHessian_;
};
}
#endif // NPSTAT_NEYMANOSDE1DRESULT_HH_
Index: trunk/npstat/stat/randomSearchForNeymanOSDE1D.hh
===================================================================
--- trunk/npstat/stat/randomSearchForNeymanOSDE1D.hh (revision 896)
+++ trunk/npstat/stat/randomSearchForNeymanOSDE1D.hh (revision 897)
@@ -1,55 +1,53 @@
#include <algorithm>
#include "npstat/rng/AbsRandomGenerator.hh"
#include "npstat/nm/scalesFromHessian.hh"
#include "npstat/stat/dampedNewtonForNeymanOSDE1D.hh"
#include "npstat/stat/DistributionsND.hh"
namespace npstat {
template<class ConvergenceCalculator>
inline NeymanOSDE1DResult randomSearchForNeymanOSDE1D(
const NeymanOSDE1D& nosde,
const double* initialCoeffs, const unsigned nCoeffs,
const double* shrinkages, const unsigned nShrinkages,
const ConvergenceCalculator& conv, const unsigned maxIterations,
AbsRandomGenerator& rng,
const unsigned nRandomTries, const double searchBandwidthFactor,
const double negativeScaleLimit = 1.0, const double dampingCoefficient = 1.0)
{
- const unsigned minimizerCode = 3U;
-
std::vector<NeymanOSDE1DResult> results;
results.reserve(nRandomTries + 1U);
std::vector<double> coeffs(initialCoeffs, initialCoeffs+nCoeffs);
std::vector<double> polyStats(nShrinkages);
std::vector<double> gradient(nCoeffs);
Matrix<double> hessian(nCoeffs, nCoeffs);
const double initialChisq = nosde.chiSquare(&coeffs[0], nCoeffs,
shrinkages, nShrinkages,
&polyStats[0], &gradient[0],
&hessian);
results.push_back(NeymanOSDE1DResult(coeffs, polyStats, initialChisq,
maxAbsValue(&gradient[0], gradient.size()),
- 0U, 0U, false, false));
+ NOSDE_NOT_OPTIMIZED, 0U, false, false));
Matrix<double> covMat = covmatFromHessian(hessian, negativeScaleLimit);
covMat *= searchBandwidthFactor*searchBandwidthFactor;
GaussND gauss(&coeffs[0], nCoeffs, covMat);
for (unsigned itry=0; itry<nRandomTries; ++itry)
{
gauss.random(rng, &coeffs[0], nCoeffs);
results.push_back(dampedNewtonForNeymanOSDE1D(
nosde, &coeffs[0], nCoeffs, shrinkages, nShrinkages,
conv, maxIterations, dampingCoefficient));
}
const unsigned imin = std::distance(results.begin(), std::min_element(
results.begin(), results.end()));
- results[imin].setMinimizerCode(minimizerCode);
+ results[imin].setMinimizerCode(NOSDE_RANDOM_SEARCH);
return results[imin];
}
}
Index: trunk/npstat/stat/Makefile.am
===================================================================
--- trunk/npstat/stat/Makefile.am (revision 896)
+++ trunk/npstat/stat/Makefile.am (revision 897)
@@ -1,461 +1,462 @@
AM_CPPFLAGS = -I@top_srcdir@/ $(DEPS_CFLAGS)
noinst_LTLIBRARIES = libstat.la
libstat_la_SOURCES = AbsDistribution1D.cc AbsUnfoldND.cc AbsKDE1DKernel.cc \
AbsDistributionND.cc amiseOptimalBandwidth.cc CompositeDistribution1D.cc \
CompositeDistributionND.cc CopulaInterpolationND.cc SymbetaParams1D.cc \
Distribution1DFactory.cc Distribution1DReader.cc DistributionNDReader.cc \
Distributions1D.cc DistributionsND.cc CrossCovarianceAccumulator.cc \
fitSbParameters.cc StatAccumulatorArr.cc HistoAxis.cc ResponseMatrix.cc \
InterpolatedDistribution1D.cc JohnsonCurves.cc JohnsonKDESmoother.cc \
LocalPolyFilter1D.cc logLikelihoodPeak.cc PolyFilterCollection1D.cc \
SbMomentsBigGamma.cc SbMomentsCalculator.cc gaussianResponseMatrix.cc \
SequentialCopulaSmoother.cc SequentialPolyFilterND.cc StatAccumulator.cc \
UnitMapInterpolationND.cc WeightedStatAccumulator.cc AbsNtuple.cc \
QuadraticOrthoPolyND.cc NMCombinationSequencer.cc Filter1DBuilders.cc \
StatAccumulatorPair.cc GridRandomizer.cc ConstantBandwidthSmoother1D.cc \
GaussianMixture1D.cc HistoNDCdf.cc NUHistoAxis.cc AllSymbetaParams1D.cc \
distributionReadError.cc WeightedStatAccumulatorPair.cc AbsUnfold1D.cc \
ProductSymmetricBetaNDCdf.cc DualHistoAxis.cc multinomialCovariance1D.cc \
StorableMultivariateFunctor.cc StorableMultivariateFunctorReader.cc \
TruncatedDistribution1D.cc neymanPearsonWindow1D.cc AsinhTransform1D.cc \
LOrPEMarginalSmoother.cc LeftCensoredDistribution.cc QuantileTable1D.cc \
RightCensoredDistribution.cc AbsDiscreteDistribution1D.cc convertAxis.cc \
DiscreteDistribution1DReader.cc DiscreteDistributions1D.cc lorpeMise1D.cc \
BernsteinFilter1DBuilder.cc BetaFilter1DBuilder.cc AbsFilter1DBuilder.cc \
continuousDegreeTaper.cc RatioOfNormals.cc AbsCVCopulaSmoother.cc \
DensityScan1D.cc BoundaryHandling.cc SmoothedEMUnfold1D.cc Copulas.cc \
PearsonsChiSquared.cc BinnedKSTest1D.cc MultiscaleEMUnfold1D.cc \
AbsBinnedComparison1D.cc BinnedADTest1D.cc LocalPolyFilter1DReader.cc \
MemoizingSymbetaFilterProvider.cc UGaussConvolution1D.cc BinSummary.cc \
SmoothedEMUnfoldND.cc UnfoldingFilterNDReader.cc AbsUnfoldingFilterND.cc \
UnfoldingBandwidthScannerND.cc DistributionMix1D.cc ScalableGaussND.cc \
InterpolatedDistro1D1P.cc AbsDistributionTransform1D.cc LogTransform1D.cc \
DistributionTransform1DReader.cc TransformedDistribution1D.cc AbsCGF1D.cc \
WeightTableFilter1DBuilder.cc VerticallyInterpolatedDistribution1D.cc \
LocalMultiFilter1D.cc LogRatioTransform1D.cc IdentityTransform1D.cc \
VariableBandwidthSmoother1D.cc AbsMarginalSmootherBase.cc OSDE1D.cc \
buildInterpolatedHelpers.cc GridInterpolatedDistribution.cc StatUtils.cc \
AbsCopulaSmootherBase.cc BernsteinCopulaSmoother.cc distro1DStats.cc \
SequentialGroupedCopulaSmoother.cc UnfoldingBandwidthScanner1D.cc \
InterpolatedDistro1DNP.cc volumeDensityFromBinnedRadial.cc \
statUncertainties.cc LocationScaleFamily1D.cc SinhAsinhTransform1D.cc \
KDE1DHOSymbetaKernel.cc EdgeworthSeriesMethod.cc scannedKSDistance.cc \
EdgeworthSeries1D.cc DeltaMixture1D.cc LikelihoodStatisticType.cc \
likelihoodStatisticCumulants.cc GaussianMixtureEntry.cc SeriesCGF1D.cc \
correctDensityEstimateGHU.cc ComparisonDistribution1D.cc \
DistributionMixND.cc DiscreteGauss1DBuilder.cc DensityOrthoPoly1D.cc \
scanMultivariateDensityAsWeight.cc scanSymmetricDensityAsWeight.cc \
DiscreteGaussCopulaSmoother.cc ExpTiltedDistribution1D.cc \
saddlepointDistribution1D.cc MatrixFilter1DBuilder.cc SineGOFTest1D.cc \
PolynomialDistro1D.cc AbsUnbinnedGOFTest1D.cc OrthoPolyGOFTest1D.cc \
UnbinnedGOFTests1D.cc UnbinnedGOFTest1DFactory.cc SmoothCDGOFTest1D.cc \
LOrPE1DSymbetaKernel.cc FoldedDistribution1D.cc solveForLOrPEWeights.cc \
bivariateChiSquare.cc EllipticalDistribution.cc PowerTransform1D.cc \
PowerHalfCauchy1D.cc PowerRatio1D.cc EllipticalDistributions.cc \
make_UnbinnedGOFTest1D.cc AbsTwoDistros1DFunctor.cc johnsonTransform.cc \
TwoDistros1DFunctors.cc AbsSmoothGOFTest1D.cc LocScaleTransform1D.cc \
LognormalTransform1D.cc JohnsonOrthoPoly1D.cc johnsonIntegral.cc \
randomOrthogonalMatrix.cc LegendreDistro1D.cc CdfTransform1D.cc \
- ChebyshevDistro1D.cc KernelSensitivityCalculator.cc NeymanOSDE1D.cc
+ ChebyshevDistro1D.cc KernelSensitivityCalculator.cc NeymanOSDE1D.cc \
+ NeymanOSDE1DResult.cc
includedir = ${prefix}/include/npstat/stat
include_HEADERS = AbsBandwidthCV.hh \
AbsBandwidthGCV.hh \
AbsBinnedComparison1D.hh \
AbsBinnedComparison1D.icc \
AbsCGF1D.hh \
AbsCompositeDistroBuilder.hh \
AbsCompositeDistroBuilder.icc \
AbsCopulaSmootherBase.hh \
AbsCopulaSmootherBase.icc \
AbsCVCopulaSmoother.hh \
AbsDiscreteDistribution1D.hh \
AbsDistribution1D.hh \
AbsDistribution1D.icc \
AbsDistributionND.hh \
AbsDistributionND.icc \
AbsDistributionTransform1D.hh \
AbsDistro1DBuilder.hh \
AbsDistro1DBuilder.icc \
AbsFilter1DBuilder.hh \
AbsInterpolatedDistribution1D.hh \
AbsInterpolationAlgoND.hh \
AbsKDE1DKernel.hh \
AbsKDE1DKernel.icc \
AbsLossCalculator.hh \
AbsMarginalSmootherBase.hh \
AbsMarginalSmootherBase.icc \
AbsNtuple.hh \
AbsNtuple.icc \
AbsPolyFilter1D.hh \
AbsPolyFilterND.hh \
AbsResponseBoxBuilder.hh \
AbsResponseIntervalBuilder.hh \
AbsSmoothGOFTest1D.hh \
AbsSmoothGOFTest1D.icc \
AbsSymbetaFilterProvider.hh \
AbsTwoDistros1DFunctor.hh \
AbsUnbinnedGOFTest1D.hh \
AbsUnfold1D.hh \
AbsUnfoldingFilterND.hh \
AbsUnfoldND.hh \
AllSymbetaParams1D.hh \
amiseOptimalBandwidth.hh \
amiseOptimalBandwidth.icc \
ArchivedNtuple.hh \
ArchivedNtuple.icc \
ArrayProjectors.hh \
ArrayProjectors.icc \
arrayStats.hh \
arrayStats.icc \
AsinhTransform1D.hh \
BandwidthCVLeastSquares1D.hh \
BandwidthCVLeastSquares1D.icc \
BandwidthCVLeastSquaresND.hh \
BandwidthCVLeastSquaresND.icc \
BandwidthCVPseudoLogli1D.hh \
BandwidthCVPseudoLogli1D.icc \
BandwidthCVPseudoLogliND.hh \
BandwidthCVPseudoLogliND.icc \
BandwidthGCVLeastSquares1D.hh \
BandwidthGCVLeastSquares1D.icc \
BandwidthGCVLeastSquaresND.hh \
BandwidthGCVLeastSquaresND.icc \
BandwidthGCVPseudoLogli1D.hh \
BandwidthGCVPseudoLogli1D.icc \
BandwidthGCVPseudoLogliND.hh \
BandwidthGCVPseudoLogliND.icc \
BernsteinCopulaSmoother.hh \
BernsteinFilter1DBuilder.hh \
betaKernelsBandwidth.hh \
betaKernelsBandwidth.icc \
BetaFilter1DBuilder.hh \
BinnedADTest1D.hh \
BinnedKSTest1D.hh \
BinSummary.hh \
BinSummary.icc \
bivariateChiSquare.hh \
BoundaryHandling.hh \
BoundaryMethod.hh \
buildInterpolatedCompositeDistroND.hh \
buildInterpolatedCompositeDistroND.icc \
buildInterpolatedDistro1DNP.hh \
buildInterpolatedDistro1DNP.icc \
buildInterpolatedHelpers.hh \
CdfTransform1D.hh \
CensoredQuantileRegression.hh \
CensoredQuantileRegression.icc \
ChebyshevDistro1D.hh \
CircularBuffer.hh \
CircularBuffer.icc \
Column.hh \
Column.icc \
ComparisonDistribution1D.hh \
CompositeDistribution1D.hh \
CompositeDistributionND.hh \
CompositeDistributionND.icc \
CompositeDistros1D.hh \
ConstantBandwidthSmoother1D.hh \
ConstantBandwidthSmootherND.hh \
ConstantBandwidthSmootherND.icc \
continuousDegreeTaper.hh \
convertAxis.hh \
CopulaInterpolationND.hh \
Copulas.hh \
correctDensityEstimateGHU.hh \
CrossCovarianceAccumulator.hh \
CrossCovarianceAccumulator.icc \
cumulantConversion.hh \
cumulantConversion.icc \
cumulantUncertainties.hh \
cumulantUncertainties.icc \
CVCopulaSmoother.hh \
CVCopulaSmoother.icc \
dampedNewtonForNeymanOSDE1D.hh \
DeltaMixture1D.hh \
DeltaMixture1D.icc \
DensityAveScanND.hh \
DensityOrthoPoly1D.hh \
DensityScan1D.hh \
DensityScanND.hh \
DiscreteDistribution1DReader.hh \
DiscreteDistributions1D.hh \
DiscreteGauss1DBuilder.hh \
DiscreteGaussCopulaSmoother.hh \
discretizationErrorND.hh \
Distribution1DFactory.hh \
Distribution1DReader.hh \
DistributionTransform1DReader.hh \
DistributionMix1D.hh \
DistributionMixND.hh \
DistributionNDReader.hh \
Distributions1D.hh \
Distributions1D.icc \
DistributionsND.hh \
DistributionsND.icc \
distributionReadError.hh \
distro1DStats.hh \
DualHistoAxis.hh \
DummyCompositeDistroBuilder.hh \
DummyDistro1DBuilder.hh \
DummyResponseBoxBuilder.hh \
DummyResponseIntervalBuilder.hh \
EdgeworthSeries1D.hh \
EdgeworthSeriesMethod.hh \
EllipticalDistribution.hh \
EllipticalDistributions.hh \
empiricalCopula.hh \
empiricalCopulaHisto.hh \
empiricalCopulaHisto.icc \
empiricalCopula.icc \
ExpTiltedDistribution1D.hh \
fillHistoFromText.hh \
fillHistoFromText.icc \
Filter1DBuilders.hh \
FitUtils.hh \
FitUtils.icc \
FoldedDistribution1D.hh \
GaussianMixtureEntry.hh \
GaussianMixture1D.hh \
gaussianResponseMatrix.hh \
GCVCopulaSmoother.hh \
GCVCopulaSmoother.icc \
gradientDescentForNeymanOSDE1D.hh \
griddedRobustRegression.hh \
griddedRobustRegression.icc \
GriddedRobustRegressionStop.hh \
GridInterpolatedDistribution.hh \
GridRandomizer.hh \
HistoAxis.hh \
HistoND.hh \
HistoND.icc \
HistoNDCdf.hh \
HistoNDFunctorInstances.hh \
histoStats.hh \
histoStats.icc \
histoUtils.hh \
histoUtils.icc \
IdentityTransform1D.hh \
InMemoryNtuple.hh \
InMemoryNtuple.icc \
InterpolatedDistribution1D.hh \
InterpolatedDistro1D1P.hh \
InterpolatedDistro1DNP.hh \
interpolateHistoND.hh \
interpolateHistoND.icc \
InterpolationFunctorInstances.hh \
JohnsonCurves.hh \
johnsonIntegral.hh \
JohnsonKDESmoother.hh \
JohnsonOrthoPoly1D.hh \
johnsonTransform.hh \
KDE1D.hh \
KDE1DCV.hh \
KDE1DHOSymbetaKernel.hh \
KDECopulaSmoother.hh \
KDECopulaSmoother.icc \
KDEGroupedCopulaSmoother.hh \
KDEGroupedCopulaSmoother.icc \
KDEFilterND.hh \
KDEFilterND.icc \
kendallsTau.hh \
kendallsTau.icc \
KernelSensitivityCalculator.hh \
KernelSensitivityCalculator.icc \
LeftCensoredDistribution.hh \
LegendreDistro1D.hh \
likelihoodStatisticCumulants.hh \
LikelihoodStatisticType.hh \
LocalLogisticRegression.hh \
LocalLogisticRegression.icc \
LocalMultiFilter1D.hh \
LocalMultiFilter1D.icc \
LocalPolyFilter1D.hh \
LocalPolyFilter1D.icc \
LocalPolyFilter1DReader.hh \
LocalPolyFilterND.hh \
LocalPolyFilterND.icc \
LocalQuadraticLeastSquaresND.hh \
LocalQuadraticLeastSquaresND.icc \
LocalQuantileRegression.hh \
LocalQuantileRegression.icc \
LocationScaleFamily1D.hh \
LocationScaleTransform1.hh \
LocationScaleTransform1.icc \
LocScaleTransform1D.hh \
logLikelihoodPeak.hh \
LognormalTransform1D.hh \
LogRatioTransform1D.hh \
LogTransform1D.hh \
LOrPE1D.hh \
LOrPE1D.icc \
LOrPE1DCV.hh \
LOrPE1DCVResult.hh \
LOrPE1DFixedDegreeCVPicker.hh \
LOrPE1DFixedDegreeCVRunner.hh \
LOrPE1DFixedDegreeCVScanner.hh \
LOrPE1DSymbetaKernel.hh \
LOrPE1DSymbetaKernel.icc \
LOrPE1DVariableDegreeCVRunner.hh \
LOrPE1DVariableDegreeCVPicker.hh \
LOrPECopulaSmoother.hh \
LOrPECopulaSmoother.icc \
LOrPEGroupedCopulaSmoother.hh \
LOrPEGroupedCopulaSmoother.icc \
LOrPEMarginalSmoother.hh \
LOrPEWeightsLocalConvergence.hh \
lorpeBackgroundCVDensity1D.hh \
lorpeBackgroundCVDensity1D.icc \
lorpeBackground1D.hh \
lorpeBackground1D.icc \
lorpeMise1D.hh \
lorpeSmooth1D.hh \
lorpeSmooth1D.icc \
make_UnbinnedGOFTest1D.hh \
MatrixFilter1DBuilder.hh \
MemoizingSymbetaFilterProvider.hh \
mergeTwoHistos.hh \
mergeTwoHistos.icc \
mirrorWeight.hh \
ModulatedDistribution1D.hh \
MultiscaleEMUnfold1D.hh \
multinomialCovariance1D.hh \
MultivariateSumAccumulator.hh \
MultivariateSumsqAccumulator.hh \
MultivariateSumsqAccumulator.icc \
MultivariateWeightedSumAccumulator.hh \
MultivariateWeightedSumsqAccumulator.hh \
MultivariateWeightedSumsqAccumulator.icc \
NeymanOSDE1DConvergence.hh \
NeymanOSDE1DResult.hh \
NeymanOSDE1D.hh \
NeymanOSDE1D.icc \
neymanPearsonWindow1D.hh \
NMCombinationSequencer.hh \
NonparametricCompositeBuilder.hh \
NonparametricCompositeBuilder.icc \
NonparametricDistro1DBuilder.hh \
NonparametricDistro1DBuilder.icc \
NtHistoFill.hh \
NtNtupleFill.hh \
NtRectangularCut.hh \
NtRectangularCut.icc \
NtupleBuffer.hh \
NtupleBuffer.icc \
NtupleRecordTypes.hh \
NtupleRecordTypesFwd.hh \
NtupleReference.hh \
ntupleStats.hh \
NUHistoAxis.hh \
OrderedPointND.hh \
OrderedPointND.icc \
orthoPoly1DVProducts.hh \
orthoPoly1DVProducts.icc \
OrthoPolyGOFTest1D.hh \
OrthoPolyGOFTest1D.icc \
OSDE1D.hh \
OSDE1D.icc \
PearsonsChiSquared.hh \
polyExpectation.hh \
polyExpectation.icc \
PolyFilterCollection1D.hh \
PolynomialDistro1D.hh \
PowerHalfCauchy1D.hh \
PowerRatio1D.hh \
PowerTransform1D.hh \
productResponseMatrix.hh \
productResponseMatrix.icc \
ProductSymmetricBetaNDCdf.hh \
QuadraticOrthoPolyND.hh \
QuadraticOrthoPolyND.icc \
QuantileRegression1D.hh \
QuantileRegression1D.icc \
QuantileTable1D.hh \
randomHistoFill1D.hh \
randomHistoFill1D.icc \
randomHistoFillND.hh \
randomHistoFillND.icc \
randomOrthogonalMatrix.hh \
randomSearchForNeymanOSDE1D.hh \
RatioOfNormals.hh \
RatioResponseBoxBuilder.hh \
RatioResponseBoxBuilder.icc \
RatioResponseIntervalBuilder.hh \
RatioResponseIntervalBuilder.icc \
ResponseMatrix.hh \
RightCensoredDistribution.hh \
saddlepointDistribution1D.hh \
SampleAccumulator.hh \
SampleAccumulator.icc \
sampleDistro1DWithWeight.hh \
SbMomentsCalculator.hh \
ScalableGaussND.hh \
scannedKSDistance.hh \
scanMultivariateDensityAsWeight.hh \
scanSymmetricDensityAsWeight.hh \
semiMixLocalLogLikelihood.hh \
SequentialCopulaSmoother.hh \
SequentialCopulaSmoother.icc \
SequentialGroupedCopulaSmoother.hh \
SequentialGroupedCopulaSmoother.icc \
SequentialPolyFilterND.hh \
SequentialPolyFilterND.icc \
SeriesCGF1D.hh \
SineGOFTest1D.hh \
SineGOFTest1D.icc \
SinhAsinhTransform1D.hh \
SmoothCDGOFTest1D.hh \
SmoothCDGOFTest1D.icc \
SmoothedEMUnfold1D.hh \
SmoothedEMUnfoldND.hh \
SmoothGOFTest1D.hh \
SmoothGOFTest1D.icc \
solveForLOrPEWeights.hh \
spearmansRho.hh \
spearmansRho.icc \
StatAccumulator.hh \
StatAccumulatorArr.hh \
StatAccumulatorPair.hh \
statUncertainties.hh \
StatUtils.hh \
StatUtils.icc \
StorableHistoNDFunctor.hh \
StorableHistoNDFunctor.icc \
StorableInterpolationFunctor.hh \
StorableInterpolationFunctor.icc \
StorableMultivariateFunctor.hh \
StorableMultivariateFunctorReader.hh \
SymbetaParams1D.hh \
TransformedDistribution1D.hh \
TruncatedDistribution1D.hh \
TwoDistros1DFunctors.hh \
TwoPointsLTSLoss.hh \
TwoPointsLTSLoss.icc \
UGaussConvolution1D.hh \
UnbinnedGOFTests1D.hh \
UnbinnedGOFTests1D.icc \
UnbinnedGOFTest1DFactory.hh \
UnfoldingBandwidthScanner1D.hh \
UnfoldingBandwidthScannerND.hh \
UnfoldingFilterNDReader.hh \
UnitMapInterpolationND.hh \
variableBandwidthSmooth1D.hh \
variableBandwidthSmooth1D.icc \
VariableBandwidthSmoother1D.hh \
VerticallyInterpolatedDistribution1D.hh \
volumeDensityFromBinnedRadial.hh \
weightedCopulaHisto.hh \
weightedCopulaHisto.icc \
WeightedDistro1DPtr.hh \
WeightedLTSLoss.hh \
WeightedLTSLoss.icc \
WeightedSampleAccumulator.hh \
WeightedSampleAccumulator.icc \
WeightedStatAccumulator.hh \
WeightedStatAccumulatorPair.hh \
WeightTableFilter1DBuilder.hh
EXTRA_DIST = 00README.txt npstat_doxy.hh
Index: trunk/npstat/stat/dampedNewtonForNeymanOSDE1D.hh
===================================================================
--- trunk/npstat/stat/dampedNewtonForNeymanOSDE1D.hh (revision 896)
+++ trunk/npstat/stat/dampedNewtonForNeymanOSDE1D.hh (revision 897)
@@ -1,121 +1,124 @@
#ifndef NPSTAT_DAMPEDNEWTONFORNEYMANOSDE1D_HH_
#define NPSTAT_DAMPEDNEWTONFORNEYMANOSDE1D_HH_
#include <cmath>
#include <cassert>
#include <utility>
#include <algorithm>
#include "npstat/nm/maxAbsValue.hh"
#include "npstat/stat/NeymanOSDE1D.hh"
#include "npstat/stat/NeymanOSDE1DResult.hh"
#include "npstat/stat/NeymanOSDE1DConvergence.hh"
#include "npstat/stat/gradientDescentForNeymanOSDE1D.hh"
namespace npstat {
// The class "ConvergenceCalculator" must have a method
// "bool converged(...) const" with the same signature as the
// "converged" method of class "GradientNeymanOSDE1DConvergenceCalc".
template<class ConvergenceCalculator>
inline NeymanOSDE1DResult dampedNewtonForNeymanOSDE1D(
const NeymanOSDE1D& nosde,
const double* initialCoeffs, const unsigned nCoeffs,
const double* shrinkages, const unsigned nShrinkages,
const ConvergenceCalculator& conv, const unsigned maxIterations,
const double dampingCoefficient = 1.0,
const bool useGradientDescent = true)
{
- const unsigned minimizerCode = 1U;
-
assert(dampingCoefficient > 0.0);
std::vector<double> coeffs(initialCoeffs, initialCoeffs+nCoeffs);
std::vector<double> polyStats(nShrinkages);
std::vector<double> prevGradient(nCoeffs);
std::vector<double> currentGradient(nCoeffs);
std::vector<double> hessianEigenvalues(nCoeffs);
std::vector<double> step(nCoeffs);
Matrix<double> hessian(nCoeffs, nCoeffs);
Matrix<double> hessianEigenvectors(nCoeffs, nCoeffs);
double prevChisq = nosde.chiSquare(&coeffs[0], nCoeffs,
shrinkages, nShrinkages,
&polyStats[0], &prevGradient[0],
&hessian);
bool converged = false, badHessian = false;
unsigned iter = 0;
for (; iter<maxIterations && !converged; ++iter)
{
hessian.symEigen(&hessianEigenvalues[0], nCoeffs, &hessianEigenvectors);
for (unsigned i=0; i<nCoeffs && !badHessian; ++i)
{
if (hessianEigenvalues[i] <= 0.0)
badHessian = true;
else
hessianEigenvalues[i] = 1.0/hessianEigenvalues[i];
}
if (badHessian)
{
// Try to switch to gradient descent.
// Note that gradient descent by itself is very slow.
// We are going to terminate it as soon as it brings
// the search into a region with a positive-definite
// Hessian.
if (useGradientDescent)
{
HessianNeymanOSDE1DConvergenceCalc<ConvergenceCalculator> descentConv(conv);
const NeymanOSDE1DResult& r = gradientDescentForNeymanOSDE1D(
nosde, &coeffs[0], nCoeffs, shrinkages, nShrinkages,
descentConv, maxIterations);
if (r.converged())
{
if (descentConv.otherCalcConverged())
return r;
else
{
+ // Recalculate the Hessian
for (unsigned i=0; i<nCoeffs; ++i)
coeffs[i] = r.coeffs()[i];
prevChisq = nosde.chiSquare(&coeffs[0], nCoeffs,
shrinkages, nShrinkages,
&polyStats[0], &prevGradient[0],
&hessian);
badHessian = false;
- continue;
}
}
}
- // Don't know other ways to deal with
- // non-positive-definite Hessians here.
- break;
+ // Did we fix the Hessian? If yes, the new Hessian
+ // has to be inverted, so we have to go to the
+ // beginning of the cycle. If not, we can't do much
+ // with this optimization method.
+ if (badHessian)
+ break;
+ else
+ continue;
}
const Matrix<double>& invEigen = diag(&hessianEigenvalues[0], nCoeffs);
const Matrix<double>& invHess = invEigen.bilinear(hessianEigenvectors);
invHess.timesVector(&prevGradient[0], nCoeffs, &step[0], nCoeffs);
for (unsigned i=0; i<nCoeffs; ++i)
{
step[i] *= -dampingCoefficient;
coeffs[i] += step[i];
}
const double currentChisq = nosde.chiSquare(&coeffs[0], nCoeffs,
shrinkages, nShrinkages,
&polyStats[0], &currentGradient[0],
&hessian);
converged = conv.converged(iter, prevChisq, prevGradient, step,
currentChisq, currentGradient, hessian);
prevChisq = currentChisq;
std::swap(prevGradient, currentGradient);
}
return NeymanOSDE1DResult(coeffs, polyStats, prevChisq,
maxAbsValue(&prevGradient[0], prevGradient.size()),
- minimizerCode, iter, converged, badHessian);
+ NOSDE_NEWTON, iter, converged, badHessian);
}
}
#endif // NPSTAT_DAMPEDNEWTONFORNEYMANOSDE1D_HH_
Index: trunk/npstat/stat/Makefile
===================================================================
--- trunk/npstat/stat/Makefile (revision 896)
+++ trunk/npstat/stat/Makefile (revision 897)
@@ -1,1848 +1,1854 @@
# Makefile.in generated by automake 1.16.5 from Makefile.am.
# npstat/stat/Makefile. Generated from Makefile.in by configure.
# Copyright (C) 1994-2021 Free Software Foundation, Inc.
# This Makefile.in is free software; the Free Software Foundation
# gives unlimited permission to copy and/or distribute it,
# with or without modifications, as long as this notice is preserved.
# This program is distributed in the hope that it will be useful,
# but WITHOUT ANY WARRANTY, to the extent permitted by law; without
# even the implied warranty of MERCHANTABILITY or FITNESS FOR A
# PARTICULAR PURPOSE.
am__is_gnu_make = { \
if test -z '$(MAKELEVEL)'; then \
false; \
elif test -n '$(MAKE_HOST)'; then \
true; \
elif test -n '$(MAKE_VERSION)' && test -n '$(CURDIR)'; then \
true; \
else \
false; \
fi; \
}
am__make_running_with_option = \
case $${target_option-} in \
?) ;; \
*) echo "am__make_running_with_option: internal error: invalid" \
"target option '$${target_option-}' specified" >&2; \
exit 1;; \
esac; \
has_opt=no; \
sane_makeflags=$$MAKEFLAGS; \
if $(am__is_gnu_make); then \
sane_makeflags=$$MFLAGS; \
else \
case $$MAKEFLAGS in \
*\\[\ \ ]*) \
bs=\\; \
sane_makeflags=`printf '%s\n' "$$MAKEFLAGS" \
| sed "s/$$bs$$bs[$$bs $$bs ]*//g"`;; \
esac; \
fi; \
skip_next=no; \
strip_trailopt () \
{ \
flg=`printf '%s\n' "$$flg" | sed "s/$$1.*$$//"`; \
}; \
for flg in $$sane_makeflags; do \
test $$skip_next = yes && { skip_next=no; continue; }; \
case $$flg in \
*=*|--*) continue;; \
-*I) strip_trailopt 'I'; skip_next=yes;; \
-*I?*) strip_trailopt 'I';; \
-*O) strip_trailopt 'O'; skip_next=yes;; \
-*O?*) strip_trailopt 'O';; \
-*l) strip_trailopt 'l'; skip_next=yes;; \
-*l?*) strip_trailopt 'l';; \
-[dEDm]) skip_next=yes;; \
-[JT]) skip_next=yes;; \
esac; \
case $$flg in \
*$$target_option*) has_opt=yes; break;; \
esac; \
done; \
test $$has_opt = yes
am__make_dryrun = (target_option=n; $(am__make_running_with_option))
am__make_keepgoing = (target_option=k; $(am__make_running_with_option))
pkgdatadir = $(datadir)/npstat
pkgincludedir = $(includedir)/npstat
pkglibdir = $(libdir)/npstat
pkglibexecdir = $(libexecdir)/npstat
am__cd = CDPATH="$${ZSH_VERSION+.}$(PATH_SEPARATOR)" && cd
install_sh_DATA = $(install_sh) -c -m 644
install_sh_PROGRAM = $(install_sh) -c
install_sh_SCRIPT = $(install_sh) -c
INSTALL_HEADER = $(INSTALL_DATA)
transform = $(program_transform_name)
NORMAL_INSTALL = :
PRE_INSTALL = :
POST_INSTALL = :
NORMAL_UNINSTALL = :
PRE_UNINSTALL = :
POST_UNINSTALL = :
build_triplet = x86_64-pc-linux-gnu
host_triplet = x86_64-pc-linux-gnu
subdir = npstat/stat
ACLOCAL_M4 = $(top_srcdir)/aclocal.m4
am__aclocal_m4_deps = $(top_srcdir)/m4/libtool.m4 \
$(top_srcdir)/m4/ltoptions.m4 $(top_srcdir)/m4/ltsugar.m4 \
$(top_srcdir)/m4/ltversion.m4 $(top_srcdir)/m4/lt~obsolete.m4 \
$(top_srcdir)/configure.ac
am__configure_deps = $(am__aclocal_m4_deps) $(CONFIGURE_DEPENDENCIES) \
$(ACLOCAL_M4)
DIST_COMMON = $(srcdir)/Makefile.am $(include_HEADERS) \
$(am__DIST_COMMON)
mkinstalldirs = $(install_sh) -d
CONFIG_CLEAN_FILES =
CONFIG_CLEAN_VPATH_FILES =
LTLIBRARIES = $(noinst_LTLIBRARIES)
libstat_la_LIBADD =
am_libstat_la_OBJECTS = AbsDistribution1D.lo AbsUnfoldND.lo \
AbsKDE1DKernel.lo AbsDistributionND.lo \
amiseOptimalBandwidth.lo CompositeDistribution1D.lo \
CompositeDistributionND.lo CopulaInterpolationND.lo \
SymbetaParams1D.lo Distribution1DFactory.lo \
Distribution1DReader.lo DistributionNDReader.lo \
Distributions1D.lo DistributionsND.lo \
CrossCovarianceAccumulator.lo fitSbParameters.lo \
StatAccumulatorArr.lo HistoAxis.lo ResponseMatrix.lo \
InterpolatedDistribution1D.lo JohnsonCurves.lo \
JohnsonKDESmoother.lo LocalPolyFilter1D.lo \
logLikelihoodPeak.lo PolyFilterCollection1D.lo \
SbMomentsBigGamma.lo SbMomentsCalculator.lo \
gaussianResponseMatrix.lo SequentialCopulaSmoother.lo \
SequentialPolyFilterND.lo StatAccumulator.lo \
UnitMapInterpolationND.lo WeightedStatAccumulator.lo \
AbsNtuple.lo QuadraticOrthoPolyND.lo NMCombinationSequencer.lo \
Filter1DBuilders.lo StatAccumulatorPair.lo GridRandomizer.lo \
ConstantBandwidthSmoother1D.lo GaussianMixture1D.lo \
HistoNDCdf.lo NUHistoAxis.lo AllSymbetaParams1D.lo \
distributionReadError.lo WeightedStatAccumulatorPair.lo \
AbsUnfold1D.lo ProductSymmetricBetaNDCdf.lo DualHistoAxis.lo \
multinomialCovariance1D.lo StorableMultivariateFunctor.lo \
StorableMultivariateFunctorReader.lo \
TruncatedDistribution1D.lo neymanPearsonWindow1D.lo \
AsinhTransform1D.lo LOrPEMarginalSmoother.lo \
LeftCensoredDistribution.lo QuantileTable1D.lo \
RightCensoredDistribution.lo AbsDiscreteDistribution1D.lo \
convertAxis.lo DiscreteDistribution1DReader.lo \
DiscreteDistributions1D.lo lorpeMise1D.lo \
BernsteinFilter1DBuilder.lo BetaFilter1DBuilder.lo \
AbsFilter1DBuilder.lo continuousDegreeTaper.lo \
RatioOfNormals.lo AbsCVCopulaSmoother.lo DensityScan1D.lo \
BoundaryHandling.lo SmoothedEMUnfold1D.lo Copulas.lo \
PearsonsChiSquared.lo BinnedKSTest1D.lo \
MultiscaleEMUnfold1D.lo AbsBinnedComparison1D.lo \
BinnedADTest1D.lo LocalPolyFilter1DReader.lo \
MemoizingSymbetaFilterProvider.lo UGaussConvolution1D.lo \
BinSummary.lo SmoothedEMUnfoldND.lo UnfoldingFilterNDReader.lo \
AbsUnfoldingFilterND.lo UnfoldingBandwidthScannerND.lo \
DistributionMix1D.lo ScalableGaussND.lo \
InterpolatedDistro1D1P.lo AbsDistributionTransform1D.lo \
LogTransform1D.lo DistributionTransform1DReader.lo \
TransformedDistribution1D.lo AbsCGF1D.lo \
WeightTableFilter1DBuilder.lo \
VerticallyInterpolatedDistribution1D.lo LocalMultiFilter1D.lo \
LogRatioTransform1D.lo IdentityTransform1D.lo \
VariableBandwidthSmoother1D.lo AbsMarginalSmootherBase.lo \
OSDE1D.lo buildInterpolatedHelpers.lo \
GridInterpolatedDistribution.lo StatUtils.lo \
AbsCopulaSmootherBase.lo BernsteinCopulaSmoother.lo \
distro1DStats.lo SequentialGroupedCopulaSmoother.lo \
UnfoldingBandwidthScanner1D.lo InterpolatedDistro1DNP.lo \
volumeDensityFromBinnedRadial.lo statUncertainties.lo \
LocationScaleFamily1D.lo SinhAsinhTransform1D.lo \
KDE1DHOSymbetaKernel.lo EdgeworthSeriesMethod.lo \
scannedKSDistance.lo EdgeworthSeries1D.lo DeltaMixture1D.lo \
LikelihoodStatisticType.lo likelihoodStatisticCumulants.lo \
GaussianMixtureEntry.lo SeriesCGF1D.lo \
correctDensityEstimateGHU.lo ComparisonDistribution1D.lo \
DistributionMixND.lo DiscreteGauss1DBuilder.lo \
DensityOrthoPoly1D.lo scanMultivariateDensityAsWeight.lo \
scanSymmetricDensityAsWeight.lo DiscreteGaussCopulaSmoother.lo \
ExpTiltedDistribution1D.lo saddlepointDistribution1D.lo \
MatrixFilter1DBuilder.lo SineGOFTest1D.lo \
PolynomialDistro1D.lo AbsUnbinnedGOFTest1D.lo \
OrthoPolyGOFTest1D.lo UnbinnedGOFTests1D.lo \
UnbinnedGOFTest1DFactory.lo SmoothCDGOFTest1D.lo \
LOrPE1DSymbetaKernel.lo FoldedDistribution1D.lo \
solveForLOrPEWeights.lo bivariateChiSquare.lo \
EllipticalDistribution.lo PowerTransform1D.lo \
PowerHalfCauchy1D.lo PowerRatio1D.lo \
EllipticalDistributions.lo make_UnbinnedGOFTest1D.lo \
AbsTwoDistros1DFunctor.lo johnsonTransform.lo \
TwoDistros1DFunctors.lo AbsSmoothGOFTest1D.lo \
LocScaleTransform1D.lo LognormalTransform1D.lo \
JohnsonOrthoPoly1D.lo johnsonIntegral.lo \
randomOrthogonalMatrix.lo LegendreDistro1D.lo \
CdfTransform1D.lo ChebyshevDistro1D.lo \
- KernelSensitivityCalculator.lo NeymanOSDE1D.lo
+ KernelSensitivityCalculator.lo NeymanOSDE1D.lo \
+ NeymanOSDE1DResult.lo
libstat_la_OBJECTS = $(am_libstat_la_OBJECTS)
AM_V_lt = $(am__v_lt_$(V))
am__v_lt_ = $(am__v_lt_$(AM_DEFAULT_VERBOSITY))
am__v_lt_0 = --silent
am__v_lt_1 =
AM_V_P = $(am__v_P_$(V))
am__v_P_ = $(am__v_P_$(AM_DEFAULT_VERBOSITY))
am__v_P_0 = false
am__v_P_1 = :
AM_V_GEN = $(am__v_GEN_$(V))
am__v_GEN_ = $(am__v_GEN_$(AM_DEFAULT_VERBOSITY))
am__v_GEN_0 = @echo " GEN " $@;
am__v_GEN_1 =
AM_V_at = $(am__v_at_$(V))
am__v_at_ = $(am__v_at_$(AM_DEFAULT_VERBOSITY))
am__v_at_0 = @
am__v_at_1 =
DEFAULT_INCLUDES = -I.
depcomp = $(SHELL) $(top_srcdir)/depcomp
am__maybe_remake_depfiles = depfiles
am__depfiles_remade = ./$(DEPDIR)/AbsBinnedComparison1D.Plo \
./$(DEPDIR)/AbsCGF1D.Plo ./$(DEPDIR)/AbsCVCopulaSmoother.Plo \
./$(DEPDIR)/AbsCopulaSmootherBase.Plo \
./$(DEPDIR)/AbsDiscreteDistribution1D.Plo \
./$(DEPDIR)/AbsDistribution1D.Plo \
./$(DEPDIR)/AbsDistributionND.Plo \
./$(DEPDIR)/AbsDistributionTransform1D.Plo \
./$(DEPDIR)/AbsFilter1DBuilder.Plo \
./$(DEPDIR)/AbsKDE1DKernel.Plo \
./$(DEPDIR)/AbsMarginalSmootherBase.Plo \
./$(DEPDIR)/AbsNtuple.Plo ./$(DEPDIR)/AbsSmoothGOFTest1D.Plo \
./$(DEPDIR)/AbsTwoDistros1DFunctor.Plo \
./$(DEPDIR)/AbsUnbinnedGOFTest1D.Plo \
./$(DEPDIR)/AbsUnfold1D.Plo ./$(DEPDIR)/AbsUnfoldND.Plo \
./$(DEPDIR)/AbsUnfoldingFilterND.Plo \
./$(DEPDIR)/AllSymbetaParams1D.Plo \
./$(DEPDIR)/AsinhTransform1D.Plo \
./$(DEPDIR)/BernsteinCopulaSmoother.Plo \
./$(DEPDIR)/BernsteinFilter1DBuilder.Plo \
./$(DEPDIR)/BetaFilter1DBuilder.Plo ./$(DEPDIR)/BinSummary.Plo \
./$(DEPDIR)/BinnedADTest1D.Plo ./$(DEPDIR)/BinnedKSTest1D.Plo \
./$(DEPDIR)/BoundaryHandling.Plo \
./$(DEPDIR)/CdfTransform1D.Plo \
./$(DEPDIR)/ChebyshevDistro1D.Plo \
./$(DEPDIR)/ComparisonDistribution1D.Plo \
./$(DEPDIR)/CompositeDistribution1D.Plo \
./$(DEPDIR)/CompositeDistributionND.Plo \
./$(DEPDIR)/ConstantBandwidthSmoother1D.Plo \
./$(DEPDIR)/CopulaInterpolationND.Plo ./$(DEPDIR)/Copulas.Plo \
./$(DEPDIR)/CrossCovarianceAccumulator.Plo \
./$(DEPDIR)/DeltaMixture1D.Plo \
./$(DEPDIR)/DensityOrthoPoly1D.Plo \
./$(DEPDIR)/DensityScan1D.Plo \
./$(DEPDIR)/DiscreteDistribution1DReader.Plo \
./$(DEPDIR)/DiscreteDistributions1D.Plo \
./$(DEPDIR)/DiscreteGauss1DBuilder.Plo \
./$(DEPDIR)/DiscreteGaussCopulaSmoother.Plo \
./$(DEPDIR)/Distribution1DFactory.Plo \
./$(DEPDIR)/Distribution1DReader.Plo \
./$(DEPDIR)/DistributionMix1D.Plo \
./$(DEPDIR)/DistributionMixND.Plo \
./$(DEPDIR)/DistributionNDReader.Plo \
./$(DEPDIR)/DistributionTransform1DReader.Plo \
./$(DEPDIR)/Distributions1D.Plo \
./$(DEPDIR)/DistributionsND.Plo ./$(DEPDIR)/DualHistoAxis.Plo \
./$(DEPDIR)/EdgeworthSeries1D.Plo \
./$(DEPDIR)/EdgeworthSeriesMethod.Plo \
./$(DEPDIR)/EllipticalDistribution.Plo \
./$(DEPDIR)/EllipticalDistributions.Plo \
./$(DEPDIR)/ExpTiltedDistribution1D.Plo \
./$(DEPDIR)/Filter1DBuilders.Plo \
./$(DEPDIR)/FoldedDistribution1D.Plo \
./$(DEPDIR)/GaussianMixture1D.Plo \
./$(DEPDIR)/GaussianMixtureEntry.Plo \
./$(DEPDIR)/GridInterpolatedDistribution.Plo \
./$(DEPDIR)/GridRandomizer.Plo ./$(DEPDIR)/HistoAxis.Plo \
./$(DEPDIR)/HistoNDCdf.Plo ./$(DEPDIR)/IdentityTransform1D.Plo \
./$(DEPDIR)/InterpolatedDistribution1D.Plo \
./$(DEPDIR)/InterpolatedDistro1D1P.Plo \
./$(DEPDIR)/InterpolatedDistro1DNP.Plo \
./$(DEPDIR)/JohnsonCurves.Plo \
./$(DEPDIR)/JohnsonKDESmoother.Plo \
./$(DEPDIR)/JohnsonOrthoPoly1D.Plo \
./$(DEPDIR)/KDE1DHOSymbetaKernel.Plo \
./$(DEPDIR)/KernelSensitivityCalculator.Plo \
./$(DEPDIR)/LOrPE1DSymbetaKernel.Plo \
./$(DEPDIR)/LOrPEMarginalSmoother.Plo \
./$(DEPDIR)/LeftCensoredDistribution.Plo \
./$(DEPDIR)/LegendreDistro1D.Plo \
./$(DEPDIR)/LikelihoodStatisticType.Plo \
./$(DEPDIR)/LocScaleTransform1D.Plo \
./$(DEPDIR)/LocalMultiFilter1D.Plo \
./$(DEPDIR)/LocalPolyFilter1D.Plo \
./$(DEPDIR)/LocalPolyFilter1DReader.Plo \
./$(DEPDIR)/LocationScaleFamily1D.Plo \
./$(DEPDIR)/LogRatioTransform1D.Plo \
./$(DEPDIR)/LogTransform1D.Plo \
./$(DEPDIR)/LognormalTransform1D.Plo \
./$(DEPDIR)/MatrixFilter1DBuilder.Plo \
./$(DEPDIR)/MemoizingSymbetaFilterProvider.Plo \
./$(DEPDIR)/MultiscaleEMUnfold1D.Plo \
./$(DEPDIR)/NMCombinationSequencer.Plo \
./$(DEPDIR)/NUHistoAxis.Plo ./$(DEPDIR)/NeymanOSDE1D.Plo \
- ./$(DEPDIR)/OSDE1D.Plo ./$(DEPDIR)/OrthoPolyGOFTest1D.Plo \
+ ./$(DEPDIR)/NeymanOSDE1DResult.Plo ./$(DEPDIR)/OSDE1D.Plo \
+ ./$(DEPDIR)/OrthoPolyGOFTest1D.Plo \
./$(DEPDIR)/PearsonsChiSquared.Plo \
./$(DEPDIR)/PolyFilterCollection1D.Plo \
./$(DEPDIR)/PolynomialDistro1D.Plo \
./$(DEPDIR)/PowerHalfCauchy1D.Plo ./$(DEPDIR)/PowerRatio1D.Plo \
./$(DEPDIR)/PowerTransform1D.Plo \
./$(DEPDIR)/ProductSymmetricBetaNDCdf.Plo \
./$(DEPDIR)/QuadraticOrthoPolyND.Plo \
./$(DEPDIR)/QuantileTable1D.Plo ./$(DEPDIR)/RatioOfNormals.Plo \
./$(DEPDIR)/ResponseMatrix.Plo \
./$(DEPDIR)/RightCensoredDistribution.Plo \
./$(DEPDIR)/SbMomentsBigGamma.Plo \
./$(DEPDIR)/SbMomentsCalculator.Plo \
./$(DEPDIR)/ScalableGaussND.Plo \
./$(DEPDIR)/SequentialCopulaSmoother.Plo \
./$(DEPDIR)/SequentialGroupedCopulaSmoother.Plo \
./$(DEPDIR)/SequentialPolyFilterND.Plo \
./$(DEPDIR)/SeriesCGF1D.Plo ./$(DEPDIR)/SineGOFTest1D.Plo \
./$(DEPDIR)/SinhAsinhTransform1D.Plo \
./$(DEPDIR)/SmoothCDGOFTest1D.Plo \
./$(DEPDIR)/SmoothedEMUnfold1D.Plo \
./$(DEPDIR)/SmoothedEMUnfoldND.Plo \
./$(DEPDIR)/StatAccumulator.Plo \
./$(DEPDIR)/StatAccumulatorArr.Plo \
./$(DEPDIR)/StatAccumulatorPair.Plo ./$(DEPDIR)/StatUtils.Plo \
./$(DEPDIR)/StorableMultivariateFunctor.Plo \
./$(DEPDIR)/StorableMultivariateFunctorReader.Plo \
./$(DEPDIR)/SymbetaParams1D.Plo \
./$(DEPDIR)/TransformedDistribution1D.Plo \
./$(DEPDIR)/TruncatedDistribution1D.Plo \
./$(DEPDIR)/TwoDistros1DFunctors.Plo \
./$(DEPDIR)/UGaussConvolution1D.Plo \
./$(DEPDIR)/UnbinnedGOFTest1DFactory.Plo \
./$(DEPDIR)/UnbinnedGOFTests1D.Plo \
./$(DEPDIR)/UnfoldingBandwidthScanner1D.Plo \
./$(DEPDIR)/UnfoldingBandwidthScannerND.Plo \
./$(DEPDIR)/UnfoldingFilterNDReader.Plo \
./$(DEPDIR)/UnitMapInterpolationND.Plo \
./$(DEPDIR)/VariableBandwidthSmoother1D.Plo \
./$(DEPDIR)/VerticallyInterpolatedDistribution1D.Plo \
./$(DEPDIR)/WeightTableFilter1DBuilder.Plo \
./$(DEPDIR)/WeightedStatAccumulator.Plo \
./$(DEPDIR)/WeightedStatAccumulatorPair.Plo \
./$(DEPDIR)/amiseOptimalBandwidth.Plo \
./$(DEPDIR)/bivariateChiSquare.Plo \
./$(DEPDIR)/buildInterpolatedHelpers.Plo \
./$(DEPDIR)/continuousDegreeTaper.Plo \
./$(DEPDIR)/convertAxis.Plo \
./$(DEPDIR)/correctDensityEstimateGHU.Plo \
./$(DEPDIR)/distributionReadError.Plo \
./$(DEPDIR)/distro1DStats.Plo ./$(DEPDIR)/fitSbParameters.Plo \
./$(DEPDIR)/gaussianResponseMatrix.Plo \
./$(DEPDIR)/johnsonIntegral.Plo \
./$(DEPDIR)/johnsonTransform.Plo \
./$(DEPDIR)/likelihoodStatisticCumulants.Plo \
./$(DEPDIR)/logLikelihoodPeak.Plo ./$(DEPDIR)/lorpeMise1D.Plo \
./$(DEPDIR)/make_UnbinnedGOFTest1D.Plo \
./$(DEPDIR)/multinomialCovariance1D.Plo \
./$(DEPDIR)/neymanPearsonWindow1D.Plo \
./$(DEPDIR)/randomOrthogonalMatrix.Plo \
./$(DEPDIR)/saddlepointDistribution1D.Plo \
./$(DEPDIR)/scanMultivariateDensityAsWeight.Plo \
./$(DEPDIR)/scanSymmetricDensityAsWeight.Plo \
./$(DEPDIR)/scannedKSDistance.Plo \
./$(DEPDIR)/solveForLOrPEWeights.Plo \
./$(DEPDIR)/statUncertainties.Plo \
./$(DEPDIR)/volumeDensityFromBinnedRadial.Plo
am__mv = mv -f
CXXCOMPILE = $(CXX) $(DEFS) $(DEFAULT_INCLUDES) $(INCLUDES) \
$(AM_CPPFLAGS) $(CPPFLAGS) $(AM_CXXFLAGS) $(CXXFLAGS)
LTCXXCOMPILE = $(LIBTOOL) $(AM_V_lt) --tag=CXX $(AM_LIBTOOLFLAGS) \
$(LIBTOOLFLAGS) --mode=compile $(CXX) $(DEFS) \
$(DEFAULT_INCLUDES) $(INCLUDES) $(AM_CPPFLAGS) $(CPPFLAGS) \
$(AM_CXXFLAGS) $(CXXFLAGS)
AM_V_CXX = $(am__v_CXX_$(V))
am__v_CXX_ = $(am__v_CXX_$(AM_DEFAULT_VERBOSITY))
am__v_CXX_0 = @echo " CXX " $@;
am__v_CXX_1 =
CXXLD = $(CXX)
CXXLINK = $(LIBTOOL) $(AM_V_lt) --tag=CXX $(AM_LIBTOOLFLAGS) \
$(LIBTOOLFLAGS) --mode=link $(CXXLD) $(AM_CXXFLAGS) \
$(CXXFLAGS) $(AM_LDFLAGS) $(LDFLAGS) -o $@
AM_V_CXXLD = $(am__v_CXXLD_$(V))
am__v_CXXLD_ = $(am__v_CXXLD_$(AM_DEFAULT_VERBOSITY))
am__v_CXXLD_0 = @echo " CXXLD " $@;
am__v_CXXLD_1 =
SOURCES = $(libstat_la_SOURCES)
DIST_SOURCES = $(libstat_la_SOURCES)
am__can_run_installinfo = \
case $$AM_UPDATE_INFO_DIR in \
n|no|NO) false;; \
*) (install-info --version) >/dev/null 2>&1;; \
esac
am__vpath_adj_setup = srcdirstrip=`echo "$(srcdir)" | sed 's|.|.|g'`;
am__vpath_adj = case $$p in \
$(srcdir)/*) f=`echo "$$p" | sed "s|^$$srcdirstrip/||"`;; \
*) f=$$p;; \
esac;
am__strip_dir = f=`echo $$p | sed -e 's|^.*/||'`;
am__install_max = 40
am__nobase_strip_setup = \
srcdirstrip=`echo "$(srcdir)" | sed 's/[].[^$$\\*|]/\\\\&/g'`
am__nobase_strip = \
for p in $$list; do echo "$$p"; done | sed -e "s|$$srcdirstrip/||"
am__nobase_list = $(am__nobase_strip_setup); \
for p in $$list; do echo "$$p $$p"; done | \
sed "s| $$srcdirstrip/| |;"' / .*\//!s/ .*/ ./; s,\( .*\)/[^/]*$$,\1,' | \
$(AWK) 'BEGIN { files["."] = "" } { files[$$2] = files[$$2] " " $$1; \
if (++n[$$2] == $(am__install_max)) \
{ print $$2, files[$$2]; n[$$2] = 0; files[$$2] = "" } } \
END { for (dir in files) print dir, files[dir] }'
am__base_list = \
sed '$$!N;$$!N;$$!N;$$!N;$$!N;$$!N;$$!N;s/\n/ /g' | \
sed '$$!N;$$!N;$$!N;$$!N;s/\n/ /g'
am__uninstall_files_from_dir = { \
test -z "$$files" \
|| { test ! -d "$$dir" && test ! -f "$$dir" && test ! -r "$$dir"; } \
|| { echo " ( cd '$$dir' && rm -f" $$files ")"; \
$(am__cd) "$$dir" && rm -f $$files; }; \
}
am__installdirs = "$(DESTDIR)$(includedir)"
HEADERS = $(include_HEADERS)
am__extra_recursive_targets = python-recursive
am__tagged_files = $(HEADERS) $(SOURCES) $(TAGS_FILES) $(LISP)
# Read a list of newline-separated strings from the standard input,
# and print each of them once, without duplicates. Input order is
# *not* preserved.
am__uniquify_input = $(AWK) '\
BEGIN { nonempty = 0; } \
{ items[$$0] = 1; nonempty = 1; } \
END { if (nonempty) { for (i in items) print i; }; } \
'
# Make sure the list of sources is unique. This is necessary because,
# e.g., the same source file might be shared among _SOURCES variables
# for different programs/libraries.
am__define_uniq_tagged_files = \
list='$(am__tagged_files)'; \
unique=`for i in $$list; do \
if test -f "$$i"; then echo $$i; else echo $(srcdir)/$$i; fi; \
done | $(am__uniquify_input)`
am__DIST_COMMON = $(srcdir)/Makefile.in $(top_srcdir)/depcomp
DISTFILES = $(DIST_COMMON) $(DIST_SOURCES) $(TEXINFOS) $(EXTRA_DIST)
ACLOCAL = ${SHELL} '/home/igv/Hepforge/npstat/trunk/missing' aclocal-1.16
AMTAR = $${TAR-tar}
AM_DEFAULT_VERBOSITY = 1
AR = ar
AUTOCONF = ${SHELL} '/home/igv/Hepforge/npstat/trunk/missing' autoconf
AUTOHEADER = ${SHELL} '/home/igv/Hepforge/npstat/trunk/missing' autoheader
AUTOMAKE = ${SHELL} '/home/igv/Hepforge/npstat/trunk/missing' automake-1.16
AWK = mawk
CC = gcc
CCDEPMODE = depmode=gcc3
CFLAGS = -g -O2
CPPFLAGS =
CSCOPE = cscope
CTAGS = ctags
CXX = g++
CXXCPP = g++ -E
CXXDEPMODE = depmode=gcc3
CXXFLAGS = -std=c++11 -O3 -Wall -W -Werror
CYGPATH_W = echo
DEFS = -DPACKAGE_NAME=\"npstat\" -DPACKAGE_TARNAME=\"npstat\" -DPACKAGE_VERSION=\"5.10.0\" -DPACKAGE_STRING=\"npstat\ 5.10.0\" -DPACKAGE_BUGREPORT=\"\" -DPACKAGE_URL=\"\" -DPACKAGE=\"npstat\" -DVERSION=\"5.10.0\" -DHAVE_STDIO_H=1 -DHAVE_STDLIB_H=1 -DHAVE_STRING_H=1 -DHAVE_INTTYPES_H=1 -DHAVE_STDINT_H=1 -DHAVE_STRINGS_H=1 -DHAVE_SYS_STAT_H=1 -DHAVE_SYS_TYPES_H=1 -DHAVE_UNISTD_H=1 -DSTDC_HEADERS=1 -DHAVE_DLFCN_H=1 -DLT_OBJDIR=\".libs/\"
DEPDIR = .deps
DEPS_CFLAGS = -I/usr/local/include
DEPS_LIBS = -L/usr/local/lib -lfftw3 -lgeners -lkstest
DLLTOOL = false
DSYMUTIL =
DUMPBIN =
ECHO_C =
ECHO_N = -n
ECHO_T =
EGREP = /bin/grep -E
ETAGS = etags
EXEEXT =
F77 = g77
FFLAGS = -g -O2
FGREP = /bin/grep -F
FLIBS = -L/usr/lib/gcc/x86_64-linux-gnu/11 -L/usr/lib/gcc/x86_64-linux-gnu/11/../../../x86_64-linux-gnu -L/usr/lib/gcc/x86_64-linux-gnu/11/../../../../lib -L/lib/x86_64-linux-gnu -L/lib/../lib -L/usr/lib/x86_64-linux-gnu -L/usr/lib/../lib -L/usr/lib/gcc/x86_64-linux-gnu/11/../../.. -lgfortran -lm -lquadmath
GREP = /bin/grep
INSTALL = /bin/install -c
INSTALL_DATA = ${INSTALL} -m 644
INSTALL_PROGRAM = ${INSTALL}
INSTALL_SCRIPT = ${INSTALL}
INSTALL_STRIP_PROGRAM = $(install_sh) -c -s
LD = /bin/ld -m elf_x86_64
LDFLAGS =
LIBOBJS =
LIBS =
LIBTOOL = $(SHELL) $(top_builddir)/libtool
LIPO =
LN_S = ln -s
LTLIBOBJS =
LT_SYS_LIBRARY_PATH =
MAKEINFO = ${SHELL} '/home/igv/Hepforge/npstat/trunk/missing' makeinfo
MANIFEST_TOOL = :
MKDIR_P = /bin/mkdir -p
NM = /bin/nm -B
NMEDIT =
OBJDUMP = objdump
OBJEXT = o
OTOOL =
OTOOL64 =
PACKAGE = npstat
PACKAGE_BUGREPORT =
PACKAGE_NAME = npstat
PACKAGE_STRING = npstat 5.10.0
PACKAGE_TARNAME = npstat
PACKAGE_URL =
PACKAGE_VERSION = 5.10.0
PATH_SEPARATOR = :
PKG_CONFIG = /bin/pkg-config
PKG_CONFIG_LIBDIR =
PKG_CONFIG_PATH = /usr/local/lib/pkgconfig
RANLIB = ranlib
SED = /bin/sed
SET_MAKE =
SHELL = /bin/bash
STRIP = strip
VERSION = 5.10.0
abs_builddir = /home/igv/Hepforge/npstat/trunk/npstat/stat
abs_srcdir = /home/igv/Hepforge/npstat/trunk/npstat/stat
abs_top_builddir = /home/igv/Hepforge/npstat/trunk
abs_top_srcdir = /home/igv/Hepforge/npstat/trunk
ac_ct_AR = ar
ac_ct_CC = gcc
ac_ct_CXX = g++
ac_ct_DUMPBIN =
ac_ct_F77 = g77
am__include = include
am__leading_dot = .
am__quote =
am__tar = $${TAR-tar} chof - "$$tardir"
am__untar = $${TAR-tar} xf -
bindir = ${exec_prefix}/bin
build = x86_64-pc-linux-gnu
build_alias =
build_cpu = x86_64
build_os = linux-gnu
build_vendor = pc
builddir = .
datadir = ${datarootdir}
datarootdir = ${prefix}/share
docdir = ${datarootdir}/doc/${PACKAGE_TARNAME}
dvidir = ${docdir}
exec_prefix = ${prefix}
host = x86_64-pc-linux-gnu
host_alias =
host_cpu = x86_64
host_os = linux-gnu
host_vendor = pc
htmldir = ${docdir}
includedir = ${prefix}/include/npstat/stat
infodir = ${datarootdir}/info
install_sh = ${SHELL} /home/igv/Hepforge/npstat/trunk/install-sh
libdir = ${exec_prefix}/lib
libexecdir = ${exec_prefix}/libexec
localedir = ${datarootdir}/locale
localstatedir = ${prefix}/var
mandir = ${datarootdir}/man
mkdir_p = $(MKDIR_P)
oldincludedir = /usr/include
pdfdir = ${docdir}
prefix = /usr/local
program_transform_name = s,x,x,
psdir = ${docdir}
runstatedir = ${localstatedir}/run
sbindir = ${exec_prefix}/sbin
sharedstatedir = ${prefix}/com
srcdir = .
sysconfdir = ${prefix}/etc
target_alias =
top_build_prefix = ../../
top_builddir = ../..
top_srcdir = ../..
AM_CPPFLAGS = -I../../ $(DEPS_CFLAGS)
noinst_LTLIBRARIES = libstat.la
libstat_la_SOURCES = AbsDistribution1D.cc AbsUnfoldND.cc AbsKDE1DKernel.cc \
AbsDistributionND.cc amiseOptimalBandwidth.cc CompositeDistribution1D.cc \
CompositeDistributionND.cc CopulaInterpolationND.cc SymbetaParams1D.cc \
Distribution1DFactory.cc Distribution1DReader.cc DistributionNDReader.cc \
Distributions1D.cc DistributionsND.cc CrossCovarianceAccumulator.cc \
fitSbParameters.cc StatAccumulatorArr.cc HistoAxis.cc ResponseMatrix.cc \
InterpolatedDistribution1D.cc JohnsonCurves.cc JohnsonKDESmoother.cc \
LocalPolyFilter1D.cc logLikelihoodPeak.cc PolyFilterCollection1D.cc \
SbMomentsBigGamma.cc SbMomentsCalculator.cc gaussianResponseMatrix.cc \
SequentialCopulaSmoother.cc SequentialPolyFilterND.cc StatAccumulator.cc \
UnitMapInterpolationND.cc WeightedStatAccumulator.cc AbsNtuple.cc \
QuadraticOrthoPolyND.cc NMCombinationSequencer.cc Filter1DBuilders.cc \
StatAccumulatorPair.cc GridRandomizer.cc ConstantBandwidthSmoother1D.cc \
GaussianMixture1D.cc HistoNDCdf.cc NUHistoAxis.cc AllSymbetaParams1D.cc \
distributionReadError.cc WeightedStatAccumulatorPair.cc AbsUnfold1D.cc \
ProductSymmetricBetaNDCdf.cc DualHistoAxis.cc multinomialCovariance1D.cc \
StorableMultivariateFunctor.cc StorableMultivariateFunctorReader.cc \
TruncatedDistribution1D.cc neymanPearsonWindow1D.cc AsinhTransform1D.cc \
LOrPEMarginalSmoother.cc LeftCensoredDistribution.cc QuantileTable1D.cc \
RightCensoredDistribution.cc AbsDiscreteDistribution1D.cc convertAxis.cc \
DiscreteDistribution1DReader.cc DiscreteDistributions1D.cc lorpeMise1D.cc \
BernsteinFilter1DBuilder.cc BetaFilter1DBuilder.cc AbsFilter1DBuilder.cc \
continuousDegreeTaper.cc RatioOfNormals.cc AbsCVCopulaSmoother.cc \
DensityScan1D.cc BoundaryHandling.cc SmoothedEMUnfold1D.cc Copulas.cc \
PearsonsChiSquared.cc BinnedKSTest1D.cc MultiscaleEMUnfold1D.cc \
AbsBinnedComparison1D.cc BinnedADTest1D.cc LocalPolyFilter1DReader.cc \
MemoizingSymbetaFilterProvider.cc UGaussConvolution1D.cc BinSummary.cc \
SmoothedEMUnfoldND.cc UnfoldingFilterNDReader.cc AbsUnfoldingFilterND.cc \
UnfoldingBandwidthScannerND.cc DistributionMix1D.cc ScalableGaussND.cc \
InterpolatedDistro1D1P.cc AbsDistributionTransform1D.cc LogTransform1D.cc \
DistributionTransform1DReader.cc TransformedDistribution1D.cc AbsCGF1D.cc \
WeightTableFilter1DBuilder.cc VerticallyInterpolatedDistribution1D.cc \
LocalMultiFilter1D.cc LogRatioTransform1D.cc IdentityTransform1D.cc \
VariableBandwidthSmoother1D.cc AbsMarginalSmootherBase.cc OSDE1D.cc \
buildInterpolatedHelpers.cc GridInterpolatedDistribution.cc StatUtils.cc \
AbsCopulaSmootherBase.cc BernsteinCopulaSmoother.cc distro1DStats.cc \
SequentialGroupedCopulaSmoother.cc UnfoldingBandwidthScanner1D.cc \
InterpolatedDistro1DNP.cc volumeDensityFromBinnedRadial.cc \
statUncertainties.cc LocationScaleFamily1D.cc SinhAsinhTransform1D.cc \
KDE1DHOSymbetaKernel.cc EdgeworthSeriesMethod.cc scannedKSDistance.cc \
EdgeworthSeries1D.cc DeltaMixture1D.cc LikelihoodStatisticType.cc \
likelihoodStatisticCumulants.cc GaussianMixtureEntry.cc SeriesCGF1D.cc \
correctDensityEstimateGHU.cc ComparisonDistribution1D.cc \
DistributionMixND.cc DiscreteGauss1DBuilder.cc DensityOrthoPoly1D.cc \
scanMultivariateDensityAsWeight.cc scanSymmetricDensityAsWeight.cc \
DiscreteGaussCopulaSmoother.cc ExpTiltedDistribution1D.cc \
saddlepointDistribution1D.cc MatrixFilter1DBuilder.cc SineGOFTest1D.cc \
PolynomialDistro1D.cc AbsUnbinnedGOFTest1D.cc OrthoPolyGOFTest1D.cc \
UnbinnedGOFTests1D.cc UnbinnedGOFTest1DFactory.cc SmoothCDGOFTest1D.cc \
LOrPE1DSymbetaKernel.cc FoldedDistribution1D.cc solveForLOrPEWeights.cc \
bivariateChiSquare.cc EllipticalDistribution.cc PowerTransform1D.cc \
PowerHalfCauchy1D.cc PowerRatio1D.cc EllipticalDistributions.cc \
make_UnbinnedGOFTest1D.cc AbsTwoDistros1DFunctor.cc johnsonTransform.cc \
TwoDistros1DFunctors.cc AbsSmoothGOFTest1D.cc LocScaleTransform1D.cc \
LognormalTransform1D.cc JohnsonOrthoPoly1D.cc johnsonIntegral.cc \
randomOrthogonalMatrix.cc LegendreDistro1D.cc CdfTransform1D.cc \
- ChebyshevDistro1D.cc KernelSensitivityCalculator.cc NeymanOSDE1D.cc
+ ChebyshevDistro1D.cc KernelSensitivityCalculator.cc NeymanOSDE1D.cc \
+ NeymanOSDE1DResult.cc
include_HEADERS = AbsBandwidthCV.hh \
AbsBandwidthGCV.hh \
AbsBinnedComparison1D.hh \
AbsBinnedComparison1D.icc \
AbsCGF1D.hh \
AbsCompositeDistroBuilder.hh \
AbsCompositeDistroBuilder.icc \
AbsCopulaSmootherBase.hh \
AbsCopulaSmootherBase.icc \
AbsCVCopulaSmoother.hh \
AbsDiscreteDistribution1D.hh \
AbsDistribution1D.hh \
AbsDistribution1D.icc \
AbsDistributionND.hh \
AbsDistributionND.icc \
AbsDistributionTransform1D.hh \
AbsDistro1DBuilder.hh \
AbsDistro1DBuilder.icc \
AbsFilter1DBuilder.hh \
AbsInterpolatedDistribution1D.hh \
AbsInterpolationAlgoND.hh \
AbsKDE1DKernel.hh \
AbsKDE1DKernel.icc \
AbsLossCalculator.hh \
AbsMarginalSmootherBase.hh \
AbsMarginalSmootherBase.icc \
AbsNtuple.hh \
AbsNtuple.icc \
AbsPolyFilter1D.hh \
AbsPolyFilterND.hh \
AbsResponseBoxBuilder.hh \
AbsResponseIntervalBuilder.hh \
AbsSmoothGOFTest1D.hh \
AbsSmoothGOFTest1D.icc \
AbsSymbetaFilterProvider.hh \
AbsTwoDistros1DFunctor.hh \
AbsUnbinnedGOFTest1D.hh \
AbsUnfold1D.hh \
AbsUnfoldingFilterND.hh \
AbsUnfoldND.hh \
AllSymbetaParams1D.hh \
amiseOptimalBandwidth.hh \
amiseOptimalBandwidth.icc \
ArchivedNtuple.hh \
ArchivedNtuple.icc \
ArrayProjectors.hh \
ArrayProjectors.icc \
arrayStats.hh \
arrayStats.icc \
AsinhTransform1D.hh \
BandwidthCVLeastSquares1D.hh \
BandwidthCVLeastSquares1D.icc \
BandwidthCVLeastSquaresND.hh \
BandwidthCVLeastSquaresND.icc \
BandwidthCVPseudoLogli1D.hh \
BandwidthCVPseudoLogli1D.icc \
BandwidthCVPseudoLogliND.hh \
BandwidthCVPseudoLogliND.icc \
BandwidthGCVLeastSquares1D.hh \
BandwidthGCVLeastSquares1D.icc \
BandwidthGCVLeastSquaresND.hh \
BandwidthGCVLeastSquaresND.icc \
BandwidthGCVPseudoLogli1D.hh \
BandwidthGCVPseudoLogli1D.icc \
BandwidthGCVPseudoLogliND.hh \
BandwidthGCVPseudoLogliND.icc \
BernsteinCopulaSmoother.hh \
BernsteinFilter1DBuilder.hh \
betaKernelsBandwidth.hh \
betaKernelsBandwidth.icc \
BetaFilter1DBuilder.hh \
BinnedADTest1D.hh \
BinnedKSTest1D.hh \
BinSummary.hh \
BinSummary.icc \
bivariateChiSquare.hh \
BoundaryHandling.hh \
BoundaryMethod.hh \
buildInterpolatedCompositeDistroND.hh \
buildInterpolatedCompositeDistroND.icc \
buildInterpolatedDistro1DNP.hh \
buildInterpolatedDistro1DNP.icc \
buildInterpolatedHelpers.hh \
CdfTransform1D.hh \
CensoredQuantileRegression.hh \
CensoredQuantileRegression.icc \
ChebyshevDistro1D.hh \
CircularBuffer.hh \
CircularBuffer.icc \
Column.hh \
Column.icc \
ComparisonDistribution1D.hh \
CompositeDistribution1D.hh \
CompositeDistributionND.hh \
CompositeDistributionND.icc \
CompositeDistros1D.hh \
ConstantBandwidthSmoother1D.hh \
ConstantBandwidthSmootherND.hh \
ConstantBandwidthSmootherND.icc \
continuousDegreeTaper.hh \
convertAxis.hh \
CopulaInterpolationND.hh \
Copulas.hh \
correctDensityEstimateGHU.hh \
CrossCovarianceAccumulator.hh \
CrossCovarianceAccumulator.icc \
cumulantConversion.hh \
cumulantConversion.icc \
cumulantUncertainties.hh \
cumulantUncertainties.icc \
CVCopulaSmoother.hh \
CVCopulaSmoother.icc \
dampedNewtonForNeymanOSDE1D.hh \
DeltaMixture1D.hh \
DeltaMixture1D.icc \
DensityAveScanND.hh \
DensityOrthoPoly1D.hh \
DensityScan1D.hh \
DensityScanND.hh \
DiscreteDistribution1DReader.hh \
DiscreteDistributions1D.hh \
DiscreteGauss1DBuilder.hh \
DiscreteGaussCopulaSmoother.hh \
discretizationErrorND.hh \
Distribution1DFactory.hh \
Distribution1DReader.hh \
DistributionTransform1DReader.hh \
DistributionMix1D.hh \
DistributionMixND.hh \
DistributionNDReader.hh \
Distributions1D.hh \
Distributions1D.icc \
DistributionsND.hh \
DistributionsND.icc \
distributionReadError.hh \
distro1DStats.hh \
DualHistoAxis.hh \
DummyCompositeDistroBuilder.hh \
DummyDistro1DBuilder.hh \
DummyResponseBoxBuilder.hh \
DummyResponseIntervalBuilder.hh \
EdgeworthSeries1D.hh \
EdgeworthSeriesMethod.hh \
EllipticalDistribution.hh \
EllipticalDistributions.hh \
empiricalCopula.hh \
empiricalCopulaHisto.hh \
empiricalCopulaHisto.icc \
empiricalCopula.icc \
ExpTiltedDistribution1D.hh \
fillHistoFromText.hh \
fillHistoFromText.icc \
Filter1DBuilders.hh \
FitUtils.hh \
FitUtils.icc \
FoldedDistribution1D.hh \
GaussianMixtureEntry.hh \
GaussianMixture1D.hh \
gaussianResponseMatrix.hh \
GCVCopulaSmoother.hh \
GCVCopulaSmoother.icc \
gradientDescentForNeymanOSDE1D.hh \
griddedRobustRegression.hh \
griddedRobustRegression.icc \
GriddedRobustRegressionStop.hh \
GridInterpolatedDistribution.hh \
GridRandomizer.hh \
HistoAxis.hh \
HistoND.hh \
HistoND.icc \
HistoNDCdf.hh \
HistoNDFunctorInstances.hh \
histoStats.hh \
histoStats.icc \
histoUtils.hh \
histoUtils.icc \
IdentityTransform1D.hh \
InMemoryNtuple.hh \
InMemoryNtuple.icc \
InterpolatedDistribution1D.hh \
InterpolatedDistro1D1P.hh \
InterpolatedDistro1DNP.hh \
interpolateHistoND.hh \
interpolateHistoND.icc \
InterpolationFunctorInstances.hh \
JohnsonCurves.hh \
johnsonIntegral.hh \
JohnsonKDESmoother.hh \
JohnsonOrthoPoly1D.hh \
johnsonTransform.hh \
KDE1D.hh \
KDE1DCV.hh \
KDE1DHOSymbetaKernel.hh \
KDECopulaSmoother.hh \
KDECopulaSmoother.icc \
KDEGroupedCopulaSmoother.hh \
KDEGroupedCopulaSmoother.icc \
KDEFilterND.hh \
KDEFilterND.icc \
kendallsTau.hh \
kendallsTau.icc \
KernelSensitivityCalculator.hh \
KernelSensitivityCalculator.icc \
LeftCensoredDistribution.hh \
LegendreDistro1D.hh \
likelihoodStatisticCumulants.hh \
LikelihoodStatisticType.hh \
LocalLogisticRegression.hh \
LocalLogisticRegression.icc \
LocalMultiFilter1D.hh \
LocalMultiFilter1D.icc \
LocalPolyFilter1D.hh \
LocalPolyFilter1D.icc \
LocalPolyFilter1DReader.hh \
LocalPolyFilterND.hh \
LocalPolyFilterND.icc \
LocalQuadraticLeastSquaresND.hh \
LocalQuadraticLeastSquaresND.icc \
LocalQuantileRegression.hh \
LocalQuantileRegression.icc \
LocationScaleFamily1D.hh \
LocationScaleTransform1.hh \
LocationScaleTransform1.icc \
LocScaleTransform1D.hh \
logLikelihoodPeak.hh \
LognormalTransform1D.hh \
LogRatioTransform1D.hh \
LogTransform1D.hh \
LOrPE1D.hh \
LOrPE1D.icc \
LOrPE1DCV.hh \
LOrPE1DCVResult.hh \
LOrPE1DFixedDegreeCVPicker.hh \
LOrPE1DFixedDegreeCVRunner.hh \
LOrPE1DFixedDegreeCVScanner.hh \
LOrPE1DSymbetaKernel.hh \
LOrPE1DSymbetaKernel.icc \
LOrPE1DVariableDegreeCVRunner.hh \
LOrPE1DVariableDegreeCVPicker.hh \
LOrPECopulaSmoother.hh \
LOrPECopulaSmoother.icc \
LOrPEGroupedCopulaSmoother.hh \
LOrPEGroupedCopulaSmoother.icc \
LOrPEMarginalSmoother.hh \
LOrPEWeightsLocalConvergence.hh \
lorpeBackgroundCVDensity1D.hh \
lorpeBackgroundCVDensity1D.icc \
lorpeBackground1D.hh \
lorpeBackground1D.icc \
lorpeMise1D.hh \
lorpeSmooth1D.hh \
lorpeSmooth1D.icc \
make_UnbinnedGOFTest1D.hh \
MatrixFilter1DBuilder.hh \
MemoizingSymbetaFilterProvider.hh \
mergeTwoHistos.hh \
mergeTwoHistos.icc \
mirrorWeight.hh \
ModulatedDistribution1D.hh \
MultiscaleEMUnfold1D.hh \
multinomialCovariance1D.hh \
MultivariateSumAccumulator.hh \
MultivariateSumsqAccumulator.hh \
MultivariateSumsqAccumulator.icc \
MultivariateWeightedSumAccumulator.hh \
MultivariateWeightedSumsqAccumulator.hh \
MultivariateWeightedSumsqAccumulator.icc \
NeymanOSDE1DConvergence.hh \
NeymanOSDE1DResult.hh \
NeymanOSDE1D.hh \
NeymanOSDE1D.icc \
neymanPearsonWindow1D.hh \
NMCombinationSequencer.hh \
NonparametricCompositeBuilder.hh \
NonparametricCompositeBuilder.icc \
NonparametricDistro1DBuilder.hh \
NonparametricDistro1DBuilder.icc \
NtHistoFill.hh \
NtNtupleFill.hh \
NtRectangularCut.hh \
NtRectangularCut.icc \
NtupleBuffer.hh \
NtupleBuffer.icc \
NtupleRecordTypes.hh \
NtupleRecordTypesFwd.hh \
NtupleReference.hh \
ntupleStats.hh \
NUHistoAxis.hh \
OrderedPointND.hh \
OrderedPointND.icc \
orthoPoly1DVProducts.hh \
orthoPoly1DVProducts.icc \
OrthoPolyGOFTest1D.hh \
OrthoPolyGOFTest1D.icc \
OSDE1D.hh \
OSDE1D.icc \
PearsonsChiSquared.hh \
polyExpectation.hh \
polyExpectation.icc \
PolyFilterCollection1D.hh \
PolynomialDistro1D.hh \
PowerHalfCauchy1D.hh \
PowerRatio1D.hh \
PowerTransform1D.hh \
productResponseMatrix.hh \
productResponseMatrix.icc \
ProductSymmetricBetaNDCdf.hh \
QuadraticOrthoPolyND.hh \
QuadraticOrthoPolyND.icc \
QuantileRegression1D.hh \
QuantileRegression1D.icc \
QuantileTable1D.hh \
randomHistoFill1D.hh \
randomHistoFill1D.icc \
randomHistoFillND.hh \
randomHistoFillND.icc \
randomOrthogonalMatrix.hh \
randomSearchForNeymanOSDE1D.hh \
RatioOfNormals.hh \
RatioResponseBoxBuilder.hh \
RatioResponseBoxBuilder.icc \
RatioResponseIntervalBuilder.hh \
RatioResponseIntervalBuilder.icc \
ResponseMatrix.hh \
RightCensoredDistribution.hh \
saddlepointDistribution1D.hh \
SampleAccumulator.hh \
SampleAccumulator.icc \
sampleDistro1DWithWeight.hh \
SbMomentsCalculator.hh \
ScalableGaussND.hh \
scannedKSDistance.hh \
scanMultivariateDensityAsWeight.hh \
scanSymmetricDensityAsWeight.hh \
semiMixLocalLogLikelihood.hh \
SequentialCopulaSmoother.hh \
SequentialCopulaSmoother.icc \
SequentialGroupedCopulaSmoother.hh \
SequentialGroupedCopulaSmoother.icc \
SequentialPolyFilterND.hh \
SequentialPolyFilterND.icc \
SeriesCGF1D.hh \
SineGOFTest1D.hh \
SineGOFTest1D.icc \
SinhAsinhTransform1D.hh \
SmoothCDGOFTest1D.hh \
SmoothCDGOFTest1D.icc \
SmoothedEMUnfold1D.hh \
SmoothedEMUnfoldND.hh \
SmoothGOFTest1D.hh \
SmoothGOFTest1D.icc \
solveForLOrPEWeights.hh \
spearmansRho.hh \
spearmansRho.icc \
StatAccumulator.hh \
StatAccumulatorArr.hh \
StatAccumulatorPair.hh \
statUncertainties.hh \
StatUtils.hh \
StatUtils.icc \
StorableHistoNDFunctor.hh \
StorableHistoNDFunctor.icc \
StorableInterpolationFunctor.hh \
StorableInterpolationFunctor.icc \
StorableMultivariateFunctor.hh \
StorableMultivariateFunctorReader.hh \
SymbetaParams1D.hh \
TransformedDistribution1D.hh \
TruncatedDistribution1D.hh \
TwoDistros1DFunctors.hh \
TwoPointsLTSLoss.hh \
TwoPointsLTSLoss.icc \
UGaussConvolution1D.hh \
UnbinnedGOFTests1D.hh \
UnbinnedGOFTests1D.icc \
UnbinnedGOFTest1DFactory.hh \
UnfoldingBandwidthScanner1D.hh \
UnfoldingBandwidthScannerND.hh \
UnfoldingFilterNDReader.hh \
UnitMapInterpolationND.hh \
variableBandwidthSmooth1D.hh \
variableBandwidthSmooth1D.icc \
VariableBandwidthSmoother1D.hh \
VerticallyInterpolatedDistribution1D.hh \
volumeDensityFromBinnedRadial.hh \
weightedCopulaHisto.hh \
weightedCopulaHisto.icc \
WeightedDistro1DPtr.hh \
WeightedLTSLoss.hh \
WeightedLTSLoss.icc \
WeightedSampleAccumulator.hh \
WeightedSampleAccumulator.icc \
WeightedStatAccumulator.hh \
WeightedStatAccumulatorPair.hh \
WeightTableFilter1DBuilder.hh
EXTRA_DIST = 00README.txt npstat_doxy.hh
all: all-am
.SUFFIXES:
.SUFFIXES: .cc .lo .o .obj
$(srcdir)/Makefile.in: $(srcdir)/Makefile.am $(am__configure_deps)
@for dep in $?; do \
case '$(am__configure_deps)' in \
*$$dep*) \
( cd $(top_builddir) && $(MAKE) $(AM_MAKEFLAGS) am--refresh ) \
&& { if test -f $@; then exit 0; else break; fi; }; \
exit 1;; \
esac; \
done; \
echo ' cd $(top_srcdir) && $(AUTOMAKE) --foreign npstat/stat/Makefile'; \
$(am__cd) $(top_srcdir) && \
$(AUTOMAKE) --foreign npstat/stat/Makefile
Makefile: $(srcdir)/Makefile.in $(top_builddir)/config.status
@case '$?' in \
*config.status*) \
cd $(top_builddir) && $(MAKE) $(AM_MAKEFLAGS) am--refresh;; \
*) \
echo ' cd $(top_builddir) && $(SHELL) ./config.status $(subdir)/$@ $(am__maybe_remake_depfiles)'; \
cd $(top_builddir) && $(SHELL) ./config.status $(subdir)/$@ $(am__maybe_remake_depfiles);; \
esac;
$(top_builddir)/config.status: $(top_srcdir)/configure $(CONFIG_STATUS_DEPENDENCIES)
cd $(top_builddir) && $(MAKE) $(AM_MAKEFLAGS) am--refresh
$(top_srcdir)/configure: $(am__configure_deps)
cd $(top_builddir) && $(MAKE) $(AM_MAKEFLAGS) am--refresh
$(ACLOCAL_M4): $(am__aclocal_m4_deps)
cd $(top_builddir) && $(MAKE) $(AM_MAKEFLAGS) am--refresh
$(am__aclocal_m4_deps):
clean-noinstLTLIBRARIES:
-test -z "$(noinst_LTLIBRARIES)" || rm -f $(noinst_LTLIBRARIES)
@list='$(noinst_LTLIBRARIES)'; \
locs=`for p in $$list; do echo $$p; done | \
sed 's|^[^/]*$$|.|; s|/[^/]*$$||; s|$$|/so_locations|' | \
sort -u`; \
test -z "$$locs" || { \
echo rm -f $${locs}; \
rm -f $${locs}; \
}
libstat.la: $(libstat_la_OBJECTS) $(libstat_la_DEPENDENCIES) $(EXTRA_libstat_la_DEPENDENCIES)
$(AM_V_CXXLD)$(CXXLINK) $(libstat_la_OBJECTS) $(libstat_la_LIBADD) $(LIBS)
mostlyclean-compile:
-rm -f *.$(OBJEXT)
distclean-compile:
-rm -f *.tab.c
include ./$(DEPDIR)/AbsBinnedComparison1D.Plo # am--include-marker
include ./$(DEPDIR)/AbsCGF1D.Plo # am--include-marker
include ./$(DEPDIR)/AbsCVCopulaSmoother.Plo # am--include-marker
include ./$(DEPDIR)/AbsCopulaSmootherBase.Plo # am--include-marker
include ./$(DEPDIR)/AbsDiscreteDistribution1D.Plo # am--include-marker
include ./$(DEPDIR)/AbsDistribution1D.Plo # am--include-marker
include ./$(DEPDIR)/AbsDistributionND.Plo # am--include-marker
include ./$(DEPDIR)/AbsDistributionTransform1D.Plo # am--include-marker
include ./$(DEPDIR)/AbsFilter1DBuilder.Plo # am--include-marker
include ./$(DEPDIR)/AbsKDE1DKernel.Plo # am--include-marker
include ./$(DEPDIR)/AbsMarginalSmootherBase.Plo # am--include-marker
include ./$(DEPDIR)/AbsNtuple.Plo # am--include-marker
include ./$(DEPDIR)/AbsSmoothGOFTest1D.Plo # am--include-marker
include ./$(DEPDIR)/AbsTwoDistros1DFunctor.Plo # am--include-marker
include ./$(DEPDIR)/AbsUnbinnedGOFTest1D.Plo # am--include-marker
include ./$(DEPDIR)/AbsUnfold1D.Plo # am--include-marker
include ./$(DEPDIR)/AbsUnfoldND.Plo # am--include-marker
include ./$(DEPDIR)/AbsUnfoldingFilterND.Plo # am--include-marker
include ./$(DEPDIR)/AllSymbetaParams1D.Plo # am--include-marker
include ./$(DEPDIR)/AsinhTransform1D.Plo # am--include-marker
include ./$(DEPDIR)/BernsteinCopulaSmoother.Plo # am--include-marker
include ./$(DEPDIR)/BernsteinFilter1DBuilder.Plo # am--include-marker
include ./$(DEPDIR)/BetaFilter1DBuilder.Plo # am--include-marker
include ./$(DEPDIR)/BinSummary.Plo # am--include-marker
include ./$(DEPDIR)/BinnedADTest1D.Plo # am--include-marker
include ./$(DEPDIR)/BinnedKSTest1D.Plo # am--include-marker
include ./$(DEPDIR)/BoundaryHandling.Plo # am--include-marker
include ./$(DEPDIR)/CdfTransform1D.Plo # am--include-marker
include ./$(DEPDIR)/ChebyshevDistro1D.Plo # am--include-marker
include ./$(DEPDIR)/ComparisonDistribution1D.Plo # am--include-marker
include ./$(DEPDIR)/CompositeDistribution1D.Plo # am--include-marker
include ./$(DEPDIR)/CompositeDistributionND.Plo # am--include-marker
include ./$(DEPDIR)/ConstantBandwidthSmoother1D.Plo # am--include-marker
include ./$(DEPDIR)/CopulaInterpolationND.Plo # am--include-marker
include ./$(DEPDIR)/Copulas.Plo # am--include-marker
include ./$(DEPDIR)/CrossCovarianceAccumulator.Plo # am--include-marker
include ./$(DEPDIR)/DeltaMixture1D.Plo # am--include-marker
include ./$(DEPDIR)/DensityOrthoPoly1D.Plo # am--include-marker
include ./$(DEPDIR)/DensityScan1D.Plo # am--include-marker
include ./$(DEPDIR)/DiscreteDistribution1DReader.Plo # am--include-marker
include ./$(DEPDIR)/DiscreteDistributions1D.Plo # am--include-marker
include ./$(DEPDIR)/DiscreteGauss1DBuilder.Plo # am--include-marker
include ./$(DEPDIR)/DiscreteGaussCopulaSmoother.Plo # am--include-marker
include ./$(DEPDIR)/Distribution1DFactory.Plo # am--include-marker
include ./$(DEPDIR)/Distribution1DReader.Plo # am--include-marker
include ./$(DEPDIR)/DistributionMix1D.Plo # am--include-marker
include ./$(DEPDIR)/DistributionMixND.Plo # am--include-marker
include ./$(DEPDIR)/DistributionNDReader.Plo # am--include-marker
include ./$(DEPDIR)/DistributionTransform1DReader.Plo # am--include-marker
include ./$(DEPDIR)/Distributions1D.Plo # am--include-marker
include ./$(DEPDIR)/DistributionsND.Plo # am--include-marker
include ./$(DEPDIR)/DualHistoAxis.Plo # am--include-marker
include ./$(DEPDIR)/EdgeworthSeries1D.Plo # am--include-marker
include ./$(DEPDIR)/EdgeworthSeriesMethod.Plo # am--include-marker
include ./$(DEPDIR)/EllipticalDistribution.Plo # am--include-marker
include ./$(DEPDIR)/EllipticalDistributions.Plo # am--include-marker
include ./$(DEPDIR)/ExpTiltedDistribution1D.Plo # am--include-marker
include ./$(DEPDIR)/Filter1DBuilders.Plo # am--include-marker
include ./$(DEPDIR)/FoldedDistribution1D.Plo # am--include-marker
include ./$(DEPDIR)/GaussianMixture1D.Plo # am--include-marker
include ./$(DEPDIR)/GaussianMixtureEntry.Plo # am--include-marker
include ./$(DEPDIR)/GridInterpolatedDistribution.Plo # am--include-marker
include ./$(DEPDIR)/GridRandomizer.Plo # am--include-marker
include ./$(DEPDIR)/HistoAxis.Plo # am--include-marker
include ./$(DEPDIR)/HistoNDCdf.Plo # am--include-marker
include ./$(DEPDIR)/IdentityTransform1D.Plo # am--include-marker
include ./$(DEPDIR)/InterpolatedDistribution1D.Plo # am--include-marker
include ./$(DEPDIR)/InterpolatedDistro1D1P.Plo # am--include-marker
include ./$(DEPDIR)/InterpolatedDistro1DNP.Plo # am--include-marker
include ./$(DEPDIR)/JohnsonCurves.Plo # am--include-marker
include ./$(DEPDIR)/JohnsonKDESmoother.Plo # am--include-marker
include ./$(DEPDIR)/JohnsonOrthoPoly1D.Plo # am--include-marker
include ./$(DEPDIR)/KDE1DHOSymbetaKernel.Plo # am--include-marker
include ./$(DEPDIR)/KernelSensitivityCalculator.Plo # am--include-marker
include ./$(DEPDIR)/LOrPE1DSymbetaKernel.Plo # am--include-marker
include ./$(DEPDIR)/LOrPEMarginalSmoother.Plo # am--include-marker
include ./$(DEPDIR)/LeftCensoredDistribution.Plo # am--include-marker
include ./$(DEPDIR)/LegendreDistro1D.Plo # am--include-marker
include ./$(DEPDIR)/LikelihoodStatisticType.Plo # am--include-marker
include ./$(DEPDIR)/LocScaleTransform1D.Plo # am--include-marker
include ./$(DEPDIR)/LocalMultiFilter1D.Plo # am--include-marker
include ./$(DEPDIR)/LocalPolyFilter1D.Plo # am--include-marker
include ./$(DEPDIR)/LocalPolyFilter1DReader.Plo # am--include-marker
include ./$(DEPDIR)/LocationScaleFamily1D.Plo # am--include-marker
include ./$(DEPDIR)/LogRatioTransform1D.Plo # am--include-marker
include ./$(DEPDIR)/LogTransform1D.Plo # am--include-marker
include ./$(DEPDIR)/LognormalTransform1D.Plo # am--include-marker
include ./$(DEPDIR)/MatrixFilter1DBuilder.Plo # am--include-marker
include ./$(DEPDIR)/MemoizingSymbetaFilterProvider.Plo # am--include-marker
include ./$(DEPDIR)/MultiscaleEMUnfold1D.Plo # am--include-marker
include ./$(DEPDIR)/NMCombinationSequencer.Plo # am--include-marker
include ./$(DEPDIR)/NUHistoAxis.Plo # am--include-marker
include ./$(DEPDIR)/NeymanOSDE1D.Plo # am--include-marker
+include ./$(DEPDIR)/NeymanOSDE1DResult.Plo # am--include-marker
include ./$(DEPDIR)/OSDE1D.Plo # am--include-marker
include ./$(DEPDIR)/OrthoPolyGOFTest1D.Plo # am--include-marker
include ./$(DEPDIR)/PearsonsChiSquared.Plo # am--include-marker
include ./$(DEPDIR)/PolyFilterCollection1D.Plo # am--include-marker
include ./$(DEPDIR)/PolynomialDistro1D.Plo # am--include-marker
include ./$(DEPDIR)/PowerHalfCauchy1D.Plo # am--include-marker
include ./$(DEPDIR)/PowerRatio1D.Plo # am--include-marker
include ./$(DEPDIR)/PowerTransform1D.Plo # am--include-marker
include ./$(DEPDIR)/ProductSymmetricBetaNDCdf.Plo # am--include-marker
include ./$(DEPDIR)/QuadraticOrthoPolyND.Plo # am--include-marker
include ./$(DEPDIR)/QuantileTable1D.Plo # am--include-marker
include ./$(DEPDIR)/RatioOfNormals.Plo # am--include-marker
include ./$(DEPDIR)/ResponseMatrix.Plo # am--include-marker
include ./$(DEPDIR)/RightCensoredDistribution.Plo # am--include-marker
include ./$(DEPDIR)/SbMomentsBigGamma.Plo # am--include-marker
include ./$(DEPDIR)/SbMomentsCalculator.Plo # am--include-marker
include ./$(DEPDIR)/ScalableGaussND.Plo # am--include-marker
include ./$(DEPDIR)/SequentialCopulaSmoother.Plo # am--include-marker
include ./$(DEPDIR)/SequentialGroupedCopulaSmoother.Plo # am--include-marker
include ./$(DEPDIR)/SequentialPolyFilterND.Plo # am--include-marker
include ./$(DEPDIR)/SeriesCGF1D.Plo # am--include-marker
include ./$(DEPDIR)/SineGOFTest1D.Plo # am--include-marker
include ./$(DEPDIR)/SinhAsinhTransform1D.Plo # am--include-marker
include ./$(DEPDIR)/SmoothCDGOFTest1D.Plo # am--include-marker
include ./$(DEPDIR)/SmoothedEMUnfold1D.Plo # am--include-marker
include ./$(DEPDIR)/SmoothedEMUnfoldND.Plo # am--include-marker
include ./$(DEPDIR)/StatAccumulator.Plo # am--include-marker
include ./$(DEPDIR)/StatAccumulatorArr.Plo # am--include-marker
include ./$(DEPDIR)/StatAccumulatorPair.Plo # am--include-marker
include ./$(DEPDIR)/StatUtils.Plo # am--include-marker
include ./$(DEPDIR)/StorableMultivariateFunctor.Plo # am--include-marker
include ./$(DEPDIR)/StorableMultivariateFunctorReader.Plo # am--include-marker
include ./$(DEPDIR)/SymbetaParams1D.Plo # am--include-marker
include ./$(DEPDIR)/TransformedDistribution1D.Plo # am--include-marker
include ./$(DEPDIR)/TruncatedDistribution1D.Plo # am--include-marker
include ./$(DEPDIR)/TwoDistros1DFunctors.Plo # am--include-marker
include ./$(DEPDIR)/UGaussConvolution1D.Plo # am--include-marker
include ./$(DEPDIR)/UnbinnedGOFTest1DFactory.Plo # am--include-marker
include ./$(DEPDIR)/UnbinnedGOFTests1D.Plo # am--include-marker
include ./$(DEPDIR)/UnfoldingBandwidthScanner1D.Plo # am--include-marker
include ./$(DEPDIR)/UnfoldingBandwidthScannerND.Plo # am--include-marker
include ./$(DEPDIR)/UnfoldingFilterNDReader.Plo # am--include-marker
include ./$(DEPDIR)/UnitMapInterpolationND.Plo # am--include-marker
include ./$(DEPDIR)/VariableBandwidthSmoother1D.Plo # am--include-marker
include ./$(DEPDIR)/VerticallyInterpolatedDistribution1D.Plo # am--include-marker
include ./$(DEPDIR)/WeightTableFilter1DBuilder.Plo # am--include-marker
include ./$(DEPDIR)/WeightedStatAccumulator.Plo # am--include-marker
include ./$(DEPDIR)/WeightedStatAccumulatorPair.Plo # am--include-marker
include ./$(DEPDIR)/amiseOptimalBandwidth.Plo # am--include-marker
include ./$(DEPDIR)/bivariateChiSquare.Plo # am--include-marker
include ./$(DEPDIR)/buildInterpolatedHelpers.Plo # am--include-marker
include ./$(DEPDIR)/continuousDegreeTaper.Plo # am--include-marker
include ./$(DEPDIR)/convertAxis.Plo # am--include-marker
include ./$(DEPDIR)/correctDensityEstimateGHU.Plo # am--include-marker
include ./$(DEPDIR)/distributionReadError.Plo # am--include-marker
include ./$(DEPDIR)/distro1DStats.Plo # am--include-marker
include ./$(DEPDIR)/fitSbParameters.Plo # am--include-marker
include ./$(DEPDIR)/gaussianResponseMatrix.Plo # am--include-marker
include ./$(DEPDIR)/johnsonIntegral.Plo # am--include-marker
include ./$(DEPDIR)/johnsonTransform.Plo # am--include-marker
include ./$(DEPDIR)/likelihoodStatisticCumulants.Plo # am--include-marker
include ./$(DEPDIR)/logLikelihoodPeak.Plo # am--include-marker
include ./$(DEPDIR)/lorpeMise1D.Plo # am--include-marker
include ./$(DEPDIR)/make_UnbinnedGOFTest1D.Plo # am--include-marker
include ./$(DEPDIR)/multinomialCovariance1D.Plo # am--include-marker
include ./$(DEPDIR)/neymanPearsonWindow1D.Plo # am--include-marker
include ./$(DEPDIR)/randomOrthogonalMatrix.Plo # am--include-marker
include ./$(DEPDIR)/saddlepointDistribution1D.Plo # am--include-marker
include ./$(DEPDIR)/scanMultivariateDensityAsWeight.Plo # am--include-marker
include ./$(DEPDIR)/scanSymmetricDensityAsWeight.Plo # am--include-marker
include ./$(DEPDIR)/scannedKSDistance.Plo # am--include-marker
include ./$(DEPDIR)/solveForLOrPEWeights.Plo # am--include-marker
include ./$(DEPDIR)/statUncertainties.Plo # am--include-marker
include ./$(DEPDIR)/volumeDensityFromBinnedRadial.Plo # am--include-marker
$(am__depfiles_remade):
@$(MKDIR_P) $(@D)
@echo '# dummy' >$@-t && $(am__mv) $@-t $@
am--depfiles: $(am__depfiles_remade)
.cc.o:
$(AM_V_CXX)$(CXXCOMPILE) -MT $@ -MD -MP -MF $(DEPDIR)/$*.Tpo -c -o $@ $<
$(AM_V_at)$(am__mv) $(DEPDIR)/$*.Tpo $(DEPDIR)/$*.Po
# $(AM_V_CXX)source='$<' object='$@' libtool=no \
# DEPDIR=$(DEPDIR) $(CXXDEPMODE) $(depcomp) \
# $(AM_V_CXX_no)$(CXXCOMPILE) -c -o $@ $<
.cc.obj:
$(AM_V_CXX)$(CXXCOMPILE) -MT $@ -MD -MP -MF $(DEPDIR)/$*.Tpo -c -o $@ `$(CYGPATH_W) '$<'`
$(AM_V_at)$(am__mv) $(DEPDIR)/$*.Tpo $(DEPDIR)/$*.Po
# $(AM_V_CXX)source='$<' object='$@' libtool=no \
# DEPDIR=$(DEPDIR) $(CXXDEPMODE) $(depcomp) \
# $(AM_V_CXX_no)$(CXXCOMPILE) -c -o $@ `$(CYGPATH_W) '$<'`
.cc.lo:
$(AM_V_CXX)$(LTCXXCOMPILE) -MT $@ -MD -MP -MF $(DEPDIR)/$*.Tpo -c -o $@ $<
$(AM_V_at)$(am__mv) $(DEPDIR)/$*.Tpo $(DEPDIR)/$*.Plo
# $(AM_V_CXX)source='$<' object='$@' libtool=yes \
# DEPDIR=$(DEPDIR) $(CXXDEPMODE) $(depcomp) \
# $(AM_V_CXX_no)$(LTCXXCOMPILE) -c -o $@ $<
mostlyclean-libtool:
-rm -f *.lo
clean-libtool:
-rm -rf .libs _libs
install-includeHEADERS: $(include_HEADERS)
@$(NORMAL_INSTALL)
@list='$(include_HEADERS)'; test -n "$(includedir)" || list=; \
if test -n "$$list"; then \
echo " $(MKDIR_P) '$(DESTDIR)$(includedir)'"; \
$(MKDIR_P) "$(DESTDIR)$(includedir)" || exit 1; \
fi; \
for p in $$list; do \
if test -f "$$p"; then d=; else d="$(srcdir)/"; fi; \
echo "$$d$$p"; \
done | $(am__base_list) | \
while read files; do \
echo " $(INSTALL_HEADER) $$files '$(DESTDIR)$(includedir)'"; \
$(INSTALL_HEADER) $$files "$(DESTDIR)$(includedir)" || exit $$?; \
done
uninstall-includeHEADERS:
@$(NORMAL_UNINSTALL)
@list='$(include_HEADERS)'; test -n "$(includedir)" || list=; \
files=`for p in $$list; do echo $$p; done | sed -e 's|^.*/||'`; \
dir='$(DESTDIR)$(includedir)'; $(am__uninstall_files_from_dir)
python-local:
ID: $(am__tagged_files)
$(am__define_uniq_tagged_files); mkid -fID $$unique
tags: tags-am
TAGS: tags
tags-am: $(TAGS_DEPENDENCIES) $(am__tagged_files)
set x; \
here=`pwd`; \
$(am__define_uniq_tagged_files); \
shift; \
if test -z "$(ETAGS_ARGS)$$*$$unique"; then :; else \
test -n "$$unique" || unique=$$empty_fix; \
if test $$# -gt 0; then \
$(ETAGS) $(ETAGSFLAGS) $(AM_ETAGSFLAGS) $(ETAGS_ARGS) \
"$$@" $$unique; \
else \
$(ETAGS) $(ETAGSFLAGS) $(AM_ETAGSFLAGS) $(ETAGS_ARGS) \
$$unique; \
fi; \
fi
ctags: ctags-am
CTAGS: ctags
ctags-am: $(TAGS_DEPENDENCIES) $(am__tagged_files)
$(am__define_uniq_tagged_files); \
test -z "$(CTAGS_ARGS)$$unique" \
|| $(CTAGS) $(CTAGSFLAGS) $(AM_CTAGSFLAGS) $(CTAGS_ARGS) \
$$unique
GTAGS:
here=`$(am__cd) $(top_builddir) && pwd` \
&& $(am__cd) $(top_srcdir) \
&& gtags -i $(GTAGS_ARGS) "$$here"
cscopelist: cscopelist-am
cscopelist-am: $(am__tagged_files)
list='$(am__tagged_files)'; \
case "$(srcdir)" in \
[\\/]* | ?:[\\/]*) sdir="$(srcdir)" ;; \
*) sdir=$(subdir)/$(srcdir) ;; \
esac; \
for i in $$list; do \
if test -f "$$i"; then \
echo "$(subdir)/$$i"; \
else \
echo "$$sdir/$$i"; \
fi; \
done >> $(top_builddir)/cscope.files
distclean-tags:
-rm -f TAGS ID GTAGS GRTAGS GSYMS GPATH tags
distdir: $(BUILT_SOURCES)
$(MAKE) $(AM_MAKEFLAGS) distdir-am
distdir-am: $(DISTFILES)
@srcdirstrip=`echo "$(srcdir)" | sed 's/[].[^$$\\*]/\\\\&/g'`; \
topsrcdirstrip=`echo "$(top_srcdir)" | sed 's/[].[^$$\\*]/\\\\&/g'`; \
list='$(DISTFILES)'; \
dist_files=`for file in $$list; do echo $$file; done | \
sed -e "s|^$$srcdirstrip/||;t" \
-e "s|^$$topsrcdirstrip/|$(top_builddir)/|;t"`; \
case $$dist_files in \
*/*) $(MKDIR_P) `echo "$$dist_files" | \
sed '/\//!d;s|^|$(distdir)/|;s,/[^/]*$$,,' | \
sort -u` ;; \
esac; \
for file in $$dist_files; do \
if test -f $$file || test -d $$file; then d=.; else d=$(srcdir); fi; \
if test -d $$d/$$file; then \
dir=`echo "/$$file" | sed -e 's,/[^/]*$$,,'`; \
if test -d "$(distdir)/$$file"; then \
find "$(distdir)/$$file" -type d ! -perm -700 -exec chmod u+rwx {} \;; \
fi; \
if test -d $(srcdir)/$$file && test $$d != $(srcdir); then \
cp -fpR $(srcdir)/$$file "$(distdir)$$dir" || exit 1; \
find "$(distdir)/$$file" -type d ! -perm -700 -exec chmod u+rwx {} \;; \
fi; \
cp -fpR $$d/$$file "$(distdir)$$dir" || exit 1; \
else \
test -f "$(distdir)/$$file" \
|| cp -p $$d/$$file "$(distdir)/$$file" \
|| exit 1; \
fi; \
done
check-am: all-am
check: check-am
all-am: Makefile $(LTLIBRARIES) $(HEADERS)
installdirs:
for dir in "$(DESTDIR)$(includedir)"; do \
test -z "$$dir" || $(MKDIR_P) "$$dir"; \
done
install: install-am
install-exec: install-exec-am
install-data: install-data-am
uninstall: uninstall-am
install-am: all-am
@$(MAKE) $(AM_MAKEFLAGS) install-exec-am install-data-am
installcheck: installcheck-am
install-strip:
if test -z '$(STRIP)'; then \
$(MAKE) $(AM_MAKEFLAGS) INSTALL_PROGRAM="$(INSTALL_STRIP_PROGRAM)" \
install_sh_PROGRAM="$(INSTALL_STRIP_PROGRAM)" INSTALL_STRIP_FLAG=-s \
install; \
else \
$(MAKE) $(AM_MAKEFLAGS) INSTALL_PROGRAM="$(INSTALL_STRIP_PROGRAM)" \
install_sh_PROGRAM="$(INSTALL_STRIP_PROGRAM)" INSTALL_STRIP_FLAG=-s \
"INSTALL_PROGRAM_ENV=STRIPPROG='$(STRIP)'" install; \
fi
mostlyclean-generic:
clean-generic:
distclean-generic:
-test -z "$(CONFIG_CLEAN_FILES)" || rm -f $(CONFIG_CLEAN_FILES)
-test . = "$(srcdir)" || test -z "$(CONFIG_CLEAN_VPATH_FILES)" || rm -f $(CONFIG_CLEAN_VPATH_FILES)
maintainer-clean-generic:
@echo "This command is intended for maintainers to use"
@echo "it deletes files that may require special tools to rebuild."
clean: clean-am
clean-am: clean-generic clean-libtool clean-noinstLTLIBRARIES \
mostlyclean-am
distclean: distclean-am
-rm -f ./$(DEPDIR)/AbsBinnedComparison1D.Plo
-rm -f ./$(DEPDIR)/AbsCGF1D.Plo
-rm -f ./$(DEPDIR)/AbsCVCopulaSmoother.Plo
-rm -f ./$(DEPDIR)/AbsCopulaSmootherBase.Plo
-rm -f ./$(DEPDIR)/AbsDiscreteDistribution1D.Plo
-rm -f ./$(DEPDIR)/AbsDistribution1D.Plo
-rm -f ./$(DEPDIR)/AbsDistributionND.Plo
-rm -f ./$(DEPDIR)/AbsDistributionTransform1D.Plo
-rm -f ./$(DEPDIR)/AbsFilter1DBuilder.Plo
-rm -f ./$(DEPDIR)/AbsKDE1DKernel.Plo
-rm -f ./$(DEPDIR)/AbsMarginalSmootherBase.Plo
-rm -f ./$(DEPDIR)/AbsNtuple.Plo
-rm -f ./$(DEPDIR)/AbsSmoothGOFTest1D.Plo
-rm -f ./$(DEPDIR)/AbsTwoDistros1DFunctor.Plo
-rm -f ./$(DEPDIR)/AbsUnbinnedGOFTest1D.Plo
-rm -f ./$(DEPDIR)/AbsUnfold1D.Plo
-rm -f ./$(DEPDIR)/AbsUnfoldND.Plo
-rm -f ./$(DEPDIR)/AbsUnfoldingFilterND.Plo
-rm -f ./$(DEPDIR)/AllSymbetaParams1D.Plo
-rm -f ./$(DEPDIR)/AsinhTransform1D.Plo
-rm -f ./$(DEPDIR)/BernsteinCopulaSmoother.Plo
-rm -f ./$(DEPDIR)/BernsteinFilter1DBuilder.Plo
-rm -f ./$(DEPDIR)/BetaFilter1DBuilder.Plo
-rm -f ./$(DEPDIR)/BinSummary.Plo
-rm -f ./$(DEPDIR)/BinnedADTest1D.Plo
-rm -f ./$(DEPDIR)/BinnedKSTest1D.Plo
-rm -f ./$(DEPDIR)/BoundaryHandling.Plo
-rm -f ./$(DEPDIR)/CdfTransform1D.Plo
-rm -f ./$(DEPDIR)/ChebyshevDistro1D.Plo
-rm -f ./$(DEPDIR)/ComparisonDistribution1D.Plo
-rm -f ./$(DEPDIR)/CompositeDistribution1D.Plo
-rm -f ./$(DEPDIR)/CompositeDistributionND.Plo
-rm -f ./$(DEPDIR)/ConstantBandwidthSmoother1D.Plo
-rm -f ./$(DEPDIR)/CopulaInterpolationND.Plo
-rm -f ./$(DEPDIR)/Copulas.Plo
-rm -f ./$(DEPDIR)/CrossCovarianceAccumulator.Plo
-rm -f ./$(DEPDIR)/DeltaMixture1D.Plo
-rm -f ./$(DEPDIR)/DensityOrthoPoly1D.Plo
-rm -f ./$(DEPDIR)/DensityScan1D.Plo
-rm -f ./$(DEPDIR)/DiscreteDistribution1DReader.Plo
-rm -f ./$(DEPDIR)/DiscreteDistributions1D.Plo
-rm -f ./$(DEPDIR)/DiscreteGauss1DBuilder.Plo
-rm -f ./$(DEPDIR)/DiscreteGaussCopulaSmoother.Plo
-rm -f ./$(DEPDIR)/Distribution1DFactory.Plo
-rm -f ./$(DEPDIR)/Distribution1DReader.Plo
-rm -f ./$(DEPDIR)/DistributionMix1D.Plo
-rm -f ./$(DEPDIR)/DistributionMixND.Plo
-rm -f ./$(DEPDIR)/DistributionNDReader.Plo
-rm -f ./$(DEPDIR)/DistributionTransform1DReader.Plo
-rm -f ./$(DEPDIR)/Distributions1D.Plo
-rm -f ./$(DEPDIR)/DistributionsND.Plo
-rm -f ./$(DEPDIR)/DualHistoAxis.Plo
-rm -f ./$(DEPDIR)/EdgeworthSeries1D.Plo
-rm -f ./$(DEPDIR)/EdgeworthSeriesMethod.Plo
-rm -f ./$(DEPDIR)/EllipticalDistribution.Plo
-rm -f ./$(DEPDIR)/EllipticalDistributions.Plo
-rm -f ./$(DEPDIR)/ExpTiltedDistribution1D.Plo
-rm -f ./$(DEPDIR)/Filter1DBuilders.Plo
-rm -f ./$(DEPDIR)/FoldedDistribution1D.Plo
-rm -f ./$(DEPDIR)/GaussianMixture1D.Plo
-rm -f ./$(DEPDIR)/GaussianMixtureEntry.Plo
-rm -f ./$(DEPDIR)/GridInterpolatedDistribution.Plo
-rm -f ./$(DEPDIR)/GridRandomizer.Plo
-rm -f ./$(DEPDIR)/HistoAxis.Plo
-rm -f ./$(DEPDIR)/HistoNDCdf.Plo
-rm -f ./$(DEPDIR)/IdentityTransform1D.Plo
-rm -f ./$(DEPDIR)/InterpolatedDistribution1D.Plo
-rm -f ./$(DEPDIR)/InterpolatedDistro1D1P.Plo
-rm -f ./$(DEPDIR)/InterpolatedDistro1DNP.Plo
-rm -f ./$(DEPDIR)/JohnsonCurves.Plo
-rm -f ./$(DEPDIR)/JohnsonKDESmoother.Plo
-rm -f ./$(DEPDIR)/JohnsonOrthoPoly1D.Plo
-rm -f ./$(DEPDIR)/KDE1DHOSymbetaKernel.Plo
-rm -f ./$(DEPDIR)/KernelSensitivityCalculator.Plo
-rm -f ./$(DEPDIR)/LOrPE1DSymbetaKernel.Plo
-rm -f ./$(DEPDIR)/LOrPEMarginalSmoother.Plo
-rm -f ./$(DEPDIR)/LeftCensoredDistribution.Plo
-rm -f ./$(DEPDIR)/LegendreDistro1D.Plo
-rm -f ./$(DEPDIR)/LikelihoodStatisticType.Plo
-rm -f ./$(DEPDIR)/LocScaleTransform1D.Plo
-rm -f ./$(DEPDIR)/LocalMultiFilter1D.Plo
-rm -f ./$(DEPDIR)/LocalPolyFilter1D.Plo
-rm -f ./$(DEPDIR)/LocalPolyFilter1DReader.Plo
-rm -f ./$(DEPDIR)/LocationScaleFamily1D.Plo
-rm -f ./$(DEPDIR)/LogRatioTransform1D.Plo
-rm -f ./$(DEPDIR)/LogTransform1D.Plo
-rm -f ./$(DEPDIR)/LognormalTransform1D.Plo
-rm -f ./$(DEPDIR)/MatrixFilter1DBuilder.Plo
-rm -f ./$(DEPDIR)/MemoizingSymbetaFilterProvider.Plo
-rm -f ./$(DEPDIR)/MultiscaleEMUnfold1D.Plo
-rm -f ./$(DEPDIR)/NMCombinationSequencer.Plo
-rm -f ./$(DEPDIR)/NUHistoAxis.Plo
-rm -f ./$(DEPDIR)/NeymanOSDE1D.Plo
+ -rm -f ./$(DEPDIR)/NeymanOSDE1DResult.Plo
-rm -f ./$(DEPDIR)/OSDE1D.Plo
-rm -f ./$(DEPDIR)/OrthoPolyGOFTest1D.Plo
-rm -f ./$(DEPDIR)/PearsonsChiSquared.Plo
-rm -f ./$(DEPDIR)/PolyFilterCollection1D.Plo
-rm -f ./$(DEPDIR)/PolynomialDistro1D.Plo
-rm -f ./$(DEPDIR)/PowerHalfCauchy1D.Plo
-rm -f ./$(DEPDIR)/PowerRatio1D.Plo
-rm -f ./$(DEPDIR)/PowerTransform1D.Plo
-rm -f ./$(DEPDIR)/ProductSymmetricBetaNDCdf.Plo
-rm -f ./$(DEPDIR)/QuadraticOrthoPolyND.Plo
-rm -f ./$(DEPDIR)/QuantileTable1D.Plo
-rm -f ./$(DEPDIR)/RatioOfNormals.Plo
-rm -f ./$(DEPDIR)/ResponseMatrix.Plo
-rm -f ./$(DEPDIR)/RightCensoredDistribution.Plo
-rm -f ./$(DEPDIR)/SbMomentsBigGamma.Plo
-rm -f ./$(DEPDIR)/SbMomentsCalculator.Plo
-rm -f ./$(DEPDIR)/ScalableGaussND.Plo
-rm -f ./$(DEPDIR)/SequentialCopulaSmoother.Plo
-rm -f ./$(DEPDIR)/SequentialGroupedCopulaSmoother.Plo
-rm -f ./$(DEPDIR)/SequentialPolyFilterND.Plo
-rm -f ./$(DEPDIR)/SeriesCGF1D.Plo
-rm -f ./$(DEPDIR)/SineGOFTest1D.Plo
-rm -f ./$(DEPDIR)/SinhAsinhTransform1D.Plo
-rm -f ./$(DEPDIR)/SmoothCDGOFTest1D.Plo
-rm -f ./$(DEPDIR)/SmoothedEMUnfold1D.Plo
-rm -f ./$(DEPDIR)/SmoothedEMUnfoldND.Plo
-rm -f ./$(DEPDIR)/StatAccumulator.Plo
-rm -f ./$(DEPDIR)/StatAccumulatorArr.Plo
-rm -f ./$(DEPDIR)/StatAccumulatorPair.Plo
-rm -f ./$(DEPDIR)/StatUtils.Plo
-rm -f ./$(DEPDIR)/StorableMultivariateFunctor.Plo
-rm -f ./$(DEPDIR)/StorableMultivariateFunctorReader.Plo
-rm -f ./$(DEPDIR)/SymbetaParams1D.Plo
-rm -f ./$(DEPDIR)/TransformedDistribution1D.Plo
-rm -f ./$(DEPDIR)/TruncatedDistribution1D.Plo
-rm -f ./$(DEPDIR)/TwoDistros1DFunctors.Plo
-rm -f ./$(DEPDIR)/UGaussConvolution1D.Plo
-rm -f ./$(DEPDIR)/UnbinnedGOFTest1DFactory.Plo
-rm -f ./$(DEPDIR)/UnbinnedGOFTests1D.Plo
-rm -f ./$(DEPDIR)/UnfoldingBandwidthScanner1D.Plo
-rm -f ./$(DEPDIR)/UnfoldingBandwidthScannerND.Plo
-rm -f ./$(DEPDIR)/UnfoldingFilterNDReader.Plo
-rm -f ./$(DEPDIR)/UnitMapInterpolationND.Plo
-rm -f ./$(DEPDIR)/VariableBandwidthSmoother1D.Plo
-rm -f ./$(DEPDIR)/VerticallyInterpolatedDistribution1D.Plo
-rm -f ./$(DEPDIR)/WeightTableFilter1DBuilder.Plo
-rm -f ./$(DEPDIR)/WeightedStatAccumulator.Plo
-rm -f ./$(DEPDIR)/WeightedStatAccumulatorPair.Plo
-rm -f ./$(DEPDIR)/amiseOptimalBandwidth.Plo
-rm -f ./$(DEPDIR)/bivariateChiSquare.Plo
-rm -f ./$(DEPDIR)/buildInterpolatedHelpers.Plo
-rm -f ./$(DEPDIR)/continuousDegreeTaper.Plo
-rm -f ./$(DEPDIR)/convertAxis.Plo
-rm -f ./$(DEPDIR)/correctDensityEstimateGHU.Plo
-rm -f ./$(DEPDIR)/distributionReadError.Plo
-rm -f ./$(DEPDIR)/distro1DStats.Plo
-rm -f ./$(DEPDIR)/fitSbParameters.Plo
-rm -f ./$(DEPDIR)/gaussianResponseMatrix.Plo
-rm -f ./$(DEPDIR)/johnsonIntegral.Plo
-rm -f ./$(DEPDIR)/johnsonTransform.Plo
-rm -f ./$(DEPDIR)/likelihoodStatisticCumulants.Plo
-rm -f ./$(DEPDIR)/logLikelihoodPeak.Plo
-rm -f ./$(DEPDIR)/lorpeMise1D.Plo
-rm -f ./$(DEPDIR)/make_UnbinnedGOFTest1D.Plo
-rm -f ./$(DEPDIR)/multinomialCovariance1D.Plo
-rm -f ./$(DEPDIR)/neymanPearsonWindow1D.Plo
-rm -f ./$(DEPDIR)/randomOrthogonalMatrix.Plo
-rm -f ./$(DEPDIR)/saddlepointDistribution1D.Plo
-rm -f ./$(DEPDIR)/scanMultivariateDensityAsWeight.Plo
-rm -f ./$(DEPDIR)/scanSymmetricDensityAsWeight.Plo
-rm -f ./$(DEPDIR)/scannedKSDistance.Plo
-rm -f ./$(DEPDIR)/solveForLOrPEWeights.Plo
-rm -f ./$(DEPDIR)/statUncertainties.Plo
-rm -f ./$(DEPDIR)/volumeDensityFromBinnedRadial.Plo
-rm -f Makefile
distclean-am: clean-am distclean-compile distclean-generic \
distclean-tags
dvi: dvi-am
dvi-am:
html: html-am
html-am:
info: info-am
info-am:
install-data-am: install-includeHEADERS
install-dvi: install-dvi-am
install-dvi-am:
install-exec-am:
install-html: install-html-am
install-html-am:
install-info: install-info-am
install-info-am:
install-man:
install-pdf: install-pdf-am
install-pdf-am:
install-ps: install-ps-am
install-ps-am:
installcheck-am:
maintainer-clean: maintainer-clean-am
-rm -f ./$(DEPDIR)/AbsBinnedComparison1D.Plo
-rm -f ./$(DEPDIR)/AbsCGF1D.Plo
-rm -f ./$(DEPDIR)/AbsCVCopulaSmoother.Plo
-rm -f ./$(DEPDIR)/AbsCopulaSmootherBase.Plo
-rm -f ./$(DEPDIR)/AbsDiscreteDistribution1D.Plo
-rm -f ./$(DEPDIR)/AbsDistribution1D.Plo
-rm -f ./$(DEPDIR)/AbsDistributionND.Plo
-rm -f ./$(DEPDIR)/AbsDistributionTransform1D.Plo
-rm -f ./$(DEPDIR)/AbsFilter1DBuilder.Plo
-rm -f ./$(DEPDIR)/AbsKDE1DKernel.Plo
-rm -f ./$(DEPDIR)/AbsMarginalSmootherBase.Plo
-rm -f ./$(DEPDIR)/AbsNtuple.Plo
-rm -f ./$(DEPDIR)/AbsSmoothGOFTest1D.Plo
-rm -f ./$(DEPDIR)/AbsTwoDistros1DFunctor.Plo
-rm -f ./$(DEPDIR)/AbsUnbinnedGOFTest1D.Plo
-rm -f ./$(DEPDIR)/AbsUnfold1D.Plo
-rm -f ./$(DEPDIR)/AbsUnfoldND.Plo
-rm -f ./$(DEPDIR)/AbsUnfoldingFilterND.Plo
-rm -f ./$(DEPDIR)/AllSymbetaParams1D.Plo
-rm -f ./$(DEPDIR)/AsinhTransform1D.Plo
-rm -f ./$(DEPDIR)/BernsteinCopulaSmoother.Plo
-rm -f ./$(DEPDIR)/BernsteinFilter1DBuilder.Plo
-rm -f ./$(DEPDIR)/BetaFilter1DBuilder.Plo
-rm -f ./$(DEPDIR)/BinSummary.Plo
-rm -f ./$(DEPDIR)/BinnedADTest1D.Plo
-rm -f ./$(DEPDIR)/BinnedKSTest1D.Plo
-rm -f ./$(DEPDIR)/BoundaryHandling.Plo
-rm -f ./$(DEPDIR)/CdfTransform1D.Plo
-rm -f ./$(DEPDIR)/ChebyshevDistro1D.Plo
-rm -f ./$(DEPDIR)/ComparisonDistribution1D.Plo
-rm -f ./$(DEPDIR)/CompositeDistribution1D.Plo
-rm -f ./$(DEPDIR)/CompositeDistributionND.Plo
-rm -f ./$(DEPDIR)/ConstantBandwidthSmoother1D.Plo
-rm -f ./$(DEPDIR)/CopulaInterpolationND.Plo
-rm -f ./$(DEPDIR)/Copulas.Plo
-rm -f ./$(DEPDIR)/CrossCovarianceAccumulator.Plo
-rm -f ./$(DEPDIR)/DeltaMixture1D.Plo
-rm -f ./$(DEPDIR)/DensityOrthoPoly1D.Plo
-rm -f ./$(DEPDIR)/DensityScan1D.Plo
-rm -f ./$(DEPDIR)/DiscreteDistribution1DReader.Plo
-rm -f ./$(DEPDIR)/DiscreteDistributions1D.Plo
-rm -f ./$(DEPDIR)/DiscreteGauss1DBuilder.Plo
-rm -f ./$(DEPDIR)/DiscreteGaussCopulaSmoother.Plo
-rm -f ./$(DEPDIR)/Distribution1DFactory.Plo
-rm -f ./$(DEPDIR)/Distribution1DReader.Plo
-rm -f ./$(DEPDIR)/DistributionMix1D.Plo
-rm -f ./$(DEPDIR)/DistributionMixND.Plo
-rm -f ./$(DEPDIR)/DistributionNDReader.Plo
-rm -f ./$(DEPDIR)/DistributionTransform1DReader.Plo
-rm -f ./$(DEPDIR)/Distributions1D.Plo
-rm -f ./$(DEPDIR)/DistributionsND.Plo
-rm -f ./$(DEPDIR)/DualHistoAxis.Plo
-rm -f ./$(DEPDIR)/EdgeworthSeries1D.Plo
-rm -f ./$(DEPDIR)/EdgeworthSeriesMethod.Plo
-rm -f ./$(DEPDIR)/EllipticalDistribution.Plo
-rm -f ./$(DEPDIR)/EllipticalDistributions.Plo
-rm -f ./$(DEPDIR)/ExpTiltedDistribution1D.Plo
-rm -f ./$(DEPDIR)/Filter1DBuilders.Plo
-rm -f ./$(DEPDIR)/FoldedDistribution1D.Plo
-rm -f ./$(DEPDIR)/GaussianMixture1D.Plo
-rm -f ./$(DEPDIR)/GaussianMixtureEntry.Plo
-rm -f ./$(DEPDIR)/GridInterpolatedDistribution.Plo
-rm -f ./$(DEPDIR)/GridRandomizer.Plo
-rm -f ./$(DEPDIR)/HistoAxis.Plo
-rm -f ./$(DEPDIR)/HistoNDCdf.Plo
-rm -f ./$(DEPDIR)/IdentityTransform1D.Plo
-rm -f ./$(DEPDIR)/InterpolatedDistribution1D.Plo
-rm -f ./$(DEPDIR)/InterpolatedDistro1D1P.Plo
-rm -f ./$(DEPDIR)/InterpolatedDistro1DNP.Plo
-rm -f ./$(DEPDIR)/JohnsonCurves.Plo
-rm -f ./$(DEPDIR)/JohnsonKDESmoother.Plo
-rm -f ./$(DEPDIR)/JohnsonOrthoPoly1D.Plo
-rm -f ./$(DEPDIR)/KDE1DHOSymbetaKernel.Plo
-rm -f ./$(DEPDIR)/KernelSensitivityCalculator.Plo
-rm -f ./$(DEPDIR)/LOrPE1DSymbetaKernel.Plo
-rm -f ./$(DEPDIR)/LOrPEMarginalSmoother.Plo
-rm -f ./$(DEPDIR)/LeftCensoredDistribution.Plo
-rm -f ./$(DEPDIR)/LegendreDistro1D.Plo
-rm -f ./$(DEPDIR)/LikelihoodStatisticType.Plo
-rm -f ./$(DEPDIR)/LocScaleTransform1D.Plo
-rm -f ./$(DEPDIR)/LocalMultiFilter1D.Plo
-rm -f ./$(DEPDIR)/LocalPolyFilter1D.Plo
-rm -f ./$(DEPDIR)/LocalPolyFilter1DReader.Plo
-rm -f ./$(DEPDIR)/LocationScaleFamily1D.Plo
-rm -f ./$(DEPDIR)/LogRatioTransform1D.Plo
-rm -f ./$(DEPDIR)/LogTransform1D.Plo
-rm -f ./$(DEPDIR)/LognormalTransform1D.Plo
-rm -f ./$(DEPDIR)/MatrixFilter1DBuilder.Plo
-rm -f ./$(DEPDIR)/MemoizingSymbetaFilterProvider.Plo
-rm -f ./$(DEPDIR)/MultiscaleEMUnfold1D.Plo
-rm -f ./$(DEPDIR)/NMCombinationSequencer.Plo
-rm -f ./$(DEPDIR)/NUHistoAxis.Plo
-rm -f ./$(DEPDIR)/NeymanOSDE1D.Plo
+ -rm -f ./$(DEPDIR)/NeymanOSDE1DResult.Plo
-rm -f ./$(DEPDIR)/OSDE1D.Plo
-rm -f ./$(DEPDIR)/OrthoPolyGOFTest1D.Plo
-rm -f ./$(DEPDIR)/PearsonsChiSquared.Plo
-rm -f ./$(DEPDIR)/PolyFilterCollection1D.Plo
-rm -f ./$(DEPDIR)/PolynomialDistro1D.Plo
-rm -f ./$(DEPDIR)/PowerHalfCauchy1D.Plo
-rm -f ./$(DEPDIR)/PowerRatio1D.Plo
-rm -f ./$(DEPDIR)/PowerTransform1D.Plo
-rm -f ./$(DEPDIR)/ProductSymmetricBetaNDCdf.Plo
-rm -f ./$(DEPDIR)/QuadraticOrthoPolyND.Plo
-rm -f ./$(DEPDIR)/QuantileTable1D.Plo
-rm -f ./$(DEPDIR)/RatioOfNormals.Plo
-rm -f ./$(DEPDIR)/ResponseMatrix.Plo
-rm -f ./$(DEPDIR)/RightCensoredDistribution.Plo
-rm -f ./$(DEPDIR)/SbMomentsBigGamma.Plo
-rm -f ./$(DEPDIR)/SbMomentsCalculator.Plo
-rm -f ./$(DEPDIR)/ScalableGaussND.Plo
-rm -f ./$(DEPDIR)/SequentialCopulaSmoother.Plo
-rm -f ./$(DEPDIR)/SequentialGroupedCopulaSmoother.Plo
-rm -f ./$(DEPDIR)/SequentialPolyFilterND.Plo
-rm -f ./$(DEPDIR)/SeriesCGF1D.Plo
-rm -f ./$(DEPDIR)/SineGOFTest1D.Plo
-rm -f ./$(DEPDIR)/SinhAsinhTransform1D.Plo
-rm -f ./$(DEPDIR)/SmoothCDGOFTest1D.Plo
-rm -f ./$(DEPDIR)/SmoothedEMUnfold1D.Plo
-rm -f ./$(DEPDIR)/SmoothedEMUnfoldND.Plo
-rm -f ./$(DEPDIR)/StatAccumulator.Plo
-rm -f ./$(DEPDIR)/StatAccumulatorArr.Plo
-rm -f ./$(DEPDIR)/StatAccumulatorPair.Plo
-rm -f ./$(DEPDIR)/StatUtils.Plo
-rm -f ./$(DEPDIR)/StorableMultivariateFunctor.Plo
-rm -f ./$(DEPDIR)/StorableMultivariateFunctorReader.Plo
-rm -f ./$(DEPDIR)/SymbetaParams1D.Plo
-rm -f ./$(DEPDIR)/TransformedDistribution1D.Plo
-rm -f ./$(DEPDIR)/TruncatedDistribution1D.Plo
-rm -f ./$(DEPDIR)/TwoDistros1DFunctors.Plo
-rm -f ./$(DEPDIR)/UGaussConvolution1D.Plo
-rm -f ./$(DEPDIR)/UnbinnedGOFTest1DFactory.Plo
-rm -f ./$(DEPDIR)/UnbinnedGOFTests1D.Plo
-rm -f ./$(DEPDIR)/UnfoldingBandwidthScanner1D.Plo
-rm -f ./$(DEPDIR)/UnfoldingBandwidthScannerND.Plo
-rm -f ./$(DEPDIR)/UnfoldingFilterNDReader.Plo
-rm -f ./$(DEPDIR)/UnitMapInterpolationND.Plo
-rm -f ./$(DEPDIR)/VariableBandwidthSmoother1D.Plo
-rm -f ./$(DEPDIR)/VerticallyInterpolatedDistribution1D.Plo
-rm -f ./$(DEPDIR)/WeightTableFilter1DBuilder.Plo
-rm -f ./$(DEPDIR)/WeightedStatAccumulator.Plo
-rm -f ./$(DEPDIR)/WeightedStatAccumulatorPair.Plo
-rm -f ./$(DEPDIR)/amiseOptimalBandwidth.Plo
-rm -f ./$(DEPDIR)/bivariateChiSquare.Plo
-rm -f ./$(DEPDIR)/buildInterpolatedHelpers.Plo
-rm -f ./$(DEPDIR)/continuousDegreeTaper.Plo
-rm -f ./$(DEPDIR)/convertAxis.Plo
-rm -f ./$(DEPDIR)/correctDensityEstimateGHU.Plo
-rm -f ./$(DEPDIR)/distributionReadError.Plo
-rm -f ./$(DEPDIR)/distro1DStats.Plo
-rm -f ./$(DEPDIR)/fitSbParameters.Plo
-rm -f ./$(DEPDIR)/gaussianResponseMatrix.Plo
-rm -f ./$(DEPDIR)/johnsonIntegral.Plo
-rm -f ./$(DEPDIR)/johnsonTransform.Plo
-rm -f ./$(DEPDIR)/likelihoodStatisticCumulants.Plo
-rm -f ./$(DEPDIR)/logLikelihoodPeak.Plo
-rm -f ./$(DEPDIR)/lorpeMise1D.Plo
-rm -f ./$(DEPDIR)/make_UnbinnedGOFTest1D.Plo
-rm -f ./$(DEPDIR)/multinomialCovariance1D.Plo
-rm -f ./$(DEPDIR)/neymanPearsonWindow1D.Plo
-rm -f ./$(DEPDIR)/randomOrthogonalMatrix.Plo
-rm -f ./$(DEPDIR)/saddlepointDistribution1D.Plo
-rm -f ./$(DEPDIR)/scanMultivariateDensityAsWeight.Plo
-rm -f ./$(DEPDIR)/scanSymmetricDensityAsWeight.Plo
-rm -f ./$(DEPDIR)/scannedKSDistance.Plo
-rm -f ./$(DEPDIR)/solveForLOrPEWeights.Plo
-rm -f ./$(DEPDIR)/statUncertainties.Plo
-rm -f ./$(DEPDIR)/volumeDensityFromBinnedRadial.Plo
-rm -f Makefile
maintainer-clean-am: distclean-am maintainer-clean-generic
mostlyclean: mostlyclean-am
mostlyclean-am: mostlyclean-compile mostlyclean-generic \
mostlyclean-libtool
pdf: pdf-am
pdf-am:
ps: ps-am
ps-am:
python: python-am
python-am: python-local
uninstall-am: uninstall-includeHEADERS
.MAKE: install-am install-strip
.PHONY: CTAGS GTAGS TAGS all all-am am--depfiles check check-am clean \
clean-generic clean-libtool clean-noinstLTLIBRARIES \
cscopelist-am ctags ctags-am distclean distclean-compile \
distclean-generic distclean-libtool distclean-tags distdir dvi \
dvi-am html html-am info info-am install install-am \
install-data install-data-am install-dvi install-dvi-am \
install-exec install-exec-am install-html install-html-am \
install-includeHEADERS install-info install-info-am \
install-man install-pdf install-pdf-am install-ps \
install-ps-am install-strip installcheck installcheck-am \
installdirs maintainer-clean maintainer-clean-generic \
mostlyclean mostlyclean-compile mostlyclean-generic \
mostlyclean-libtool pdf pdf-am ps ps-am python-am python-local \
tags tags-am uninstall uninstall-am uninstall-includeHEADERS
.PRECIOUS: Makefile
# Tell versions [3.59,3.63) of GNU make to not export all variables.
# Otherwise a system limit (for SysV at least) may be exceeded.
.NOEXPORT:
Index: trunk/npstat/stat/Makefile.in
===================================================================
--- trunk/npstat/stat/Makefile.in (revision 896)
+++ trunk/npstat/stat/Makefile.in (revision 897)
@@ -1,1848 +1,1854 @@
# Makefile.in generated by automake 1.16.5 from Makefile.am.
# @configure_input@
# Copyright (C) 1994-2021 Free Software Foundation, Inc.
# This Makefile.in is free software; the Free Software Foundation
# gives unlimited permission to copy and/or distribute it,
# with or without modifications, as long as this notice is preserved.
# This program is distributed in the hope that it will be useful,
# but WITHOUT ANY WARRANTY, to the extent permitted by law; without
# even the implied warranty of MERCHANTABILITY or FITNESS FOR A
# PARTICULAR PURPOSE.
@SET_MAKE@
VPATH = @srcdir@
am__is_gnu_make = { \
if test -z '$(MAKELEVEL)'; then \
false; \
elif test -n '$(MAKE_HOST)'; then \
true; \
elif test -n '$(MAKE_VERSION)' && test -n '$(CURDIR)'; then \
true; \
else \
false; \
fi; \
}
am__make_running_with_option = \
case $${target_option-} in \
?) ;; \
*) echo "am__make_running_with_option: internal error: invalid" \
"target option '$${target_option-}' specified" >&2; \
exit 1;; \
esac; \
has_opt=no; \
sane_makeflags=$$MAKEFLAGS; \
if $(am__is_gnu_make); then \
sane_makeflags=$$MFLAGS; \
else \
case $$MAKEFLAGS in \
*\\[\ \ ]*) \
bs=\\; \
sane_makeflags=`printf '%s\n' "$$MAKEFLAGS" \
| sed "s/$$bs$$bs[$$bs $$bs ]*//g"`;; \
esac; \
fi; \
skip_next=no; \
strip_trailopt () \
{ \
flg=`printf '%s\n' "$$flg" | sed "s/$$1.*$$//"`; \
}; \
for flg in $$sane_makeflags; do \
test $$skip_next = yes && { skip_next=no; continue; }; \
case $$flg in \
*=*|--*) continue;; \
-*I) strip_trailopt 'I'; skip_next=yes;; \
-*I?*) strip_trailopt 'I';; \
-*O) strip_trailopt 'O'; skip_next=yes;; \
-*O?*) strip_trailopt 'O';; \
-*l) strip_trailopt 'l'; skip_next=yes;; \
-*l?*) strip_trailopt 'l';; \
-[dEDm]) skip_next=yes;; \
-[JT]) skip_next=yes;; \
esac; \
case $$flg in \
*$$target_option*) has_opt=yes; break;; \
esac; \
done; \
test $$has_opt = yes
am__make_dryrun = (target_option=n; $(am__make_running_with_option))
am__make_keepgoing = (target_option=k; $(am__make_running_with_option))
pkgdatadir = $(datadir)/@PACKAGE@
pkgincludedir = $(includedir)/@PACKAGE@
pkglibdir = $(libdir)/@PACKAGE@
pkglibexecdir = $(libexecdir)/@PACKAGE@
am__cd = CDPATH="$${ZSH_VERSION+.}$(PATH_SEPARATOR)" && cd
install_sh_DATA = $(install_sh) -c -m 644
install_sh_PROGRAM = $(install_sh) -c
install_sh_SCRIPT = $(install_sh) -c
INSTALL_HEADER = $(INSTALL_DATA)
transform = $(program_transform_name)
NORMAL_INSTALL = :
PRE_INSTALL = :
POST_INSTALL = :
NORMAL_UNINSTALL = :
PRE_UNINSTALL = :
POST_UNINSTALL = :
build_triplet = @build@
host_triplet = @host@
subdir = npstat/stat
ACLOCAL_M4 = $(top_srcdir)/aclocal.m4
am__aclocal_m4_deps = $(top_srcdir)/m4/libtool.m4 \
$(top_srcdir)/m4/ltoptions.m4 $(top_srcdir)/m4/ltsugar.m4 \
$(top_srcdir)/m4/ltversion.m4 $(top_srcdir)/m4/lt~obsolete.m4 \
$(top_srcdir)/configure.ac
am__configure_deps = $(am__aclocal_m4_deps) $(CONFIGURE_DEPENDENCIES) \
$(ACLOCAL_M4)
DIST_COMMON = $(srcdir)/Makefile.am $(include_HEADERS) \
$(am__DIST_COMMON)
mkinstalldirs = $(install_sh) -d
CONFIG_CLEAN_FILES =
CONFIG_CLEAN_VPATH_FILES =
LTLIBRARIES = $(noinst_LTLIBRARIES)
libstat_la_LIBADD =
am_libstat_la_OBJECTS = AbsDistribution1D.lo AbsUnfoldND.lo \
AbsKDE1DKernel.lo AbsDistributionND.lo \
amiseOptimalBandwidth.lo CompositeDistribution1D.lo \
CompositeDistributionND.lo CopulaInterpolationND.lo \
SymbetaParams1D.lo Distribution1DFactory.lo \
Distribution1DReader.lo DistributionNDReader.lo \
Distributions1D.lo DistributionsND.lo \
CrossCovarianceAccumulator.lo fitSbParameters.lo \
StatAccumulatorArr.lo HistoAxis.lo ResponseMatrix.lo \
InterpolatedDistribution1D.lo JohnsonCurves.lo \
JohnsonKDESmoother.lo LocalPolyFilter1D.lo \
logLikelihoodPeak.lo PolyFilterCollection1D.lo \
SbMomentsBigGamma.lo SbMomentsCalculator.lo \
gaussianResponseMatrix.lo SequentialCopulaSmoother.lo \
SequentialPolyFilterND.lo StatAccumulator.lo \
UnitMapInterpolationND.lo WeightedStatAccumulator.lo \
AbsNtuple.lo QuadraticOrthoPolyND.lo NMCombinationSequencer.lo \
Filter1DBuilders.lo StatAccumulatorPair.lo GridRandomizer.lo \
ConstantBandwidthSmoother1D.lo GaussianMixture1D.lo \
HistoNDCdf.lo NUHistoAxis.lo AllSymbetaParams1D.lo \
distributionReadError.lo WeightedStatAccumulatorPair.lo \
AbsUnfold1D.lo ProductSymmetricBetaNDCdf.lo DualHistoAxis.lo \
multinomialCovariance1D.lo StorableMultivariateFunctor.lo \
StorableMultivariateFunctorReader.lo \
TruncatedDistribution1D.lo neymanPearsonWindow1D.lo \
AsinhTransform1D.lo LOrPEMarginalSmoother.lo \
LeftCensoredDistribution.lo QuantileTable1D.lo \
RightCensoredDistribution.lo AbsDiscreteDistribution1D.lo \
convertAxis.lo DiscreteDistribution1DReader.lo \
DiscreteDistributions1D.lo lorpeMise1D.lo \
BernsteinFilter1DBuilder.lo BetaFilter1DBuilder.lo \
AbsFilter1DBuilder.lo continuousDegreeTaper.lo \
RatioOfNormals.lo AbsCVCopulaSmoother.lo DensityScan1D.lo \
BoundaryHandling.lo SmoothedEMUnfold1D.lo Copulas.lo \
PearsonsChiSquared.lo BinnedKSTest1D.lo \
MultiscaleEMUnfold1D.lo AbsBinnedComparison1D.lo \
BinnedADTest1D.lo LocalPolyFilter1DReader.lo \
MemoizingSymbetaFilterProvider.lo UGaussConvolution1D.lo \
BinSummary.lo SmoothedEMUnfoldND.lo UnfoldingFilterNDReader.lo \
AbsUnfoldingFilterND.lo UnfoldingBandwidthScannerND.lo \
DistributionMix1D.lo ScalableGaussND.lo \
InterpolatedDistro1D1P.lo AbsDistributionTransform1D.lo \
LogTransform1D.lo DistributionTransform1DReader.lo \
TransformedDistribution1D.lo AbsCGF1D.lo \
WeightTableFilter1DBuilder.lo \
VerticallyInterpolatedDistribution1D.lo LocalMultiFilter1D.lo \
LogRatioTransform1D.lo IdentityTransform1D.lo \
VariableBandwidthSmoother1D.lo AbsMarginalSmootherBase.lo \
OSDE1D.lo buildInterpolatedHelpers.lo \
GridInterpolatedDistribution.lo StatUtils.lo \
AbsCopulaSmootherBase.lo BernsteinCopulaSmoother.lo \
distro1DStats.lo SequentialGroupedCopulaSmoother.lo \
UnfoldingBandwidthScanner1D.lo InterpolatedDistro1DNP.lo \
volumeDensityFromBinnedRadial.lo statUncertainties.lo \
LocationScaleFamily1D.lo SinhAsinhTransform1D.lo \
KDE1DHOSymbetaKernel.lo EdgeworthSeriesMethod.lo \
scannedKSDistance.lo EdgeworthSeries1D.lo DeltaMixture1D.lo \
LikelihoodStatisticType.lo likelihoodStatisticCumulants.lo \
GaussianMixtureEntry.lo SeriesCGF1D.lo \
correctDensityEstimateGHU.lo ComparisonDistribution1D.lo \
DistributionMixND.lo DiscreteGauss1DBuilder.lo \
DensityOrthoPoly1D.lo scanMultivariateDensityAsWeight.lo \
scanSymmetricDensityAsWeight.lo DiscreteGaussCopulaSmoother.lo \
ExpTiltedDistribution1D.lo saddlepointDistribution1D.lo \
MatrixFilter1DBuilder.lo SineGOFTest1D.lo \
PolynomialDistro1D.lo AbsUnbinnedGOFTest1D.lo \
OrthoPolyGOFTest1D.lo UnbinnedGOFTests1D.lo \
UnbinnedGOFTest1DFactory.lo SmoothCDGOFTest1D.lo \
LOrPE1DSymbetaKernel.lo FoldedDistribution1D.lo \
solveForLOrPEWeights.lo bivariateChiSquare.lo \
EllipticalDistribution.lo PowerTransform1D.lo \
PowerHalfCauchy1D.lo PowerRatio1D.lo \
EllipticalDistributions.lo make_UnbinnedGOFTest1D.lo \
AbsTwoDistros1DFunctor.lo johnsonTransform.lo \
TwoDistros1DFunctors.lo AbsSmoothGOFTest1D.lo \
LocScaleTransform1D.lo LognormalTransform1D.lo \
JohnsonOrthoPoly1D.lo johnsonIntegral.lo \
randomOrthogonalMatrix.lo LegendreDistro1D.lo \
CdfTransform1D.lo ChebyshevDistro1D.lo \
- KernelSensitivityCalculator.lo NeymanOSDE1D.lo
+ KernelSensitivityCalculator.lo NeymanOSDE1D.lo \
+ NeymanOSDE1DResult.lo
libstat_la_OBJECTS = $(am_libstat_la_OBJECTS)
AM_V_lt = $(am__v_lt_@AM_V@)
am__v_lt_ = $(am__v_lt_@AM_DEFAULT_V@)
am__v_lt_0 = --silent
am__v_lt_1 =
AM_V_P = $(am__v_P_@AM_V@)
am__v_P_ = $(am__v_P_@AM_DEFAULT_V@)
am__v_P_0 = false
am__v_P_1 = :
AM_V_GEN = $(am__v_GEN_@AM_V@)
am__v_GEN_ = $(am__v_GEN_@AM_DEFAULT_V@)
am__v_GEN_0 = @echo " GEN " $@;
am__v_GEN_1 =
AM_V_at = $(am__v_at_@AM_V@)
am__v_at_ = $(am__v_at_@AM_DEFAULT_V@)
am__v_at_0 = @
am__v_at_1 =
DEFAULT_INCLUDES = -I.@am__isrc@
depcomp = $(SHELL) $(top_srcdir)/depcomp
am__maybe_remake_depfiles = depfiles
am__depfiles_remade = ./$(DEPDIR)/AbsBinnedComparison1D.Plo \
./$(DEPDIR)/AbsCGF1D.Plo ./$(DEPDIR)/AbsCVCopulaSmoother.Plo \
./$(DEPDIR)/AbsCopulaSmootherBase.Plo \
./$(DEPDIR)/AbsDiscreteDistribution1D.Plo \
./$(DEPDIR)/AbsDistribution1D.Plo \
./$(DEPDIR)/AbsDistributionND.Plo \
./$(DEPDIR)/AbsDistributionTransform1D.Plo \
./$(DEPDIR)/AbsFilter1DBuilder.Plo \
./$(DEPDIR)/AbsKDE1DKernel.Plo \
./$(DEPDIR)/AbsMarginalSmootherBase.Plo \
./$(DEPDIR)/AbsNtuple.Plo ./$(DEPDIR)/AbsSmoothGOFTest1D.Plo \
./$(DEPDIR)/AbsTwoDistros1DFunctor.Plo \
./$(DEPDIR)/AbsUnbinnedGOFTest1D.Plo \
./$(DEPDIR)/AbsUnfold1D.Plo ./$(DEPDIR)/AbsUnfoldND.Plo \
./$(DEPDIR)/AbsUnfoldingFilterND.Plo \
./$(DEPDIR)/AllSymbetaParams1D.Plo \
./$(DEPDIR)/AsinhTransform1D.Plo \
./$(DEPDIR)/BernsteinCopulaSmoother.Plo \
./$(DEPDIR)/BernsteinFilter1DBuilder.Plo \
./$(DEPDIR)/BetaFilter1DBuilder.Plo ./$(DEPDIR)/BinSummary.Plo \
./$(DEPDIR)/BinnedADTest1D.Plo ./$(DEPDIR)/BinnedKSTest1D.Plo \
./$(DEPDIR)/BoundaryHandling.Plo \
./$(DEPDIR)/CdfTransform1D.Plo \
./$(DEPDIR)/ChebyshevDistro1D.Plo \
./$(DEPDIR)/ComparisonDistribution1D.Plo \
./$(DEPDIR)/CompositeDistribution1D.Plo \
./$(DEPDIR)/CompositeDistributionND.Plo \
./$(DEPDIR)/ConstantBandwidthSmoother1D.Plo \
./$(DEPDIR)/CopulaInterpolationND.Plo ./$(DEPDIR)/Copulas.Plo \
./$(DEPDIR)/CrossCovarianceAccumulator.Plo \
./$(DEPDIR)/DeltaMixture1D.Plo \
./$(DEPDIR)/DensityOrthoPoly1D.Plo \
./$(DEPDIR)/DensityScan1D.Plo \
./$(DEPDIR)/DiscreteDistribution1DReader.Plo \
./$(DEPDIR)/DiscreteDistributions1D.Plo \
./$(DEPDIR)/DiscreteGauss1DBuilder.Plo \
./$(DEPDIR)/DiscreteGaussCopulaSmoother.Plo \
./$(DEPDIR)/Distribution1DFactory.Plo \
./$(DEPDIR)/Distribution1DReader.Plo \
./$(DEPDIR)/DistributionMix1D.Plo \
./$(DEPDIR)/DistributionMixND.Plo \
./$(DEPDIR)/DistributionNDReader.Plo \
./$(DEPDIR)/DistributionTransform1DReader.Plo \
./$(DEPDIR)/Distributions1D.Plo \
./$(DEPDIR)/DistributionsND.Plo ./$(DEPDIR)/DualHistoAxis.Plo \
./$(DEPDIR)/EdgeworthSeries1D.Plo \
./$(DEPDIR)/EdgeworthSeriesMethod.Plo \
./$(DEPDIR)/EllipticalDistribution.Plo \
./$(DEPDIR)/EllipticalDistributions.Plo \
./$(DEPDIR)/ExpTiltedDistribution1D.Plo \
./$(DEPDIR)/Filter1DBuilders.Plo \
./$(DEPDIR)/FoldedDistribution1D.Plo \
./$(DEPDIR)/GaussianMixture1D.Plo \
./$(DEPDIR)/GaussianMixtureEntry.Plo \
./$(DEPDIR)/GridInterpolatedDistribution.Plo \
./$(DEPDIR)/GridRandomizer.Plo ./$(DEPDIR)/HistoAxis.Plo \
./$(DEPDIR)/HistoNDCdf.Plo ./$(DEPDIR)/IdentityTransform1D.Plo \
./$(DEPDIR)/InterpolatedDistribution1D.Plo \
./$(DEPDIR)/InterpolatedDistro1D1P.Plo \
./$(DEPDIR)/InterpolatedDistro1DNP.Plo \
./$(DEPDIR)/JohnsonCurves.Plo \
./$(DEPDIR)/JohnsonKDESmoother.Plo \
./$(DEPDIR)/JohnsonOrthoPoly1D.Plo \
./$(DEPDIR)/KDE1DHOSymbetaKernel.Plo \
./$(DEPDIR)/KernelSensitivityCalculator.Plo \
./$(DEPDIR)/LOrPE1DSymbetaKernel.Plo \
./$(DEPDIR)/LOrPEMarginalSmoother.Plo \
./$(DEPDIR)/LeftCensoredDistribution.Plo \
./$(DEPDIR)/LegendreDistro1D.Plo \
./$(DEPDIR)/LikelihoodStatisticType.Plo \
./$(DEPDIR)/LocScaleTransform1D.Plo \
./$(DEPDIR)/LocalMultiFilter1D.Plo \
./$(DEPDIR)/LocalPolyFilter1D.Plo \
./$(DEPDIR)/LocalPolyFilter1DReader.Plo \
./$(DEPDIR)/LocationScaleFamily1D.Plo \
./$(DEPDIR)/LogRatioTransform1D.Plo \
./$(DEPDIR)/LogTransform1D.Plo \
./$(DEPDIR)/LognormalTransform1D.Plo \
./$(DEPDIR)/MatrixFilter1DBuilder.Plo \
./$(DEPDIR)/MemoizingSymbetaFilterProvider.Plo \
./$(DEPDIR)/MultiscaleEMUnfold1D.Plo \
./$(DEPDIR)/NMCombinationSequencer.Plo \
./$(DEPDIR)/NUHistoAxis.Plo ./$(DEPDIR)/NeymanOSDE1D.Plo \
- ./$(DEPDIR)/OSDE1D.Plo ./$(DEPDIR)/OrthoPolyGOFTest1D.Plo \
+ ./$(DEPDIR)/NeymanOSDE1DResult.Plo ./$(DEPDIR)/OSDE1D.Plo \
+ ./$(DEPDIR)/OrthoPolyGOFTest1D.Plo \
./$(DEPDIR)/PearsonsChiSquared.Plo \
./$(DEPDIR)/PolyFilterCollection1D.Plo \
./$(DEPDIR)/PolynomialDistro1D.Plo \
./$(DEPDIR)/PowerHalfCauchy1D.Plo ./$(DEPDIR)/PowerRatio1D.Plo \
./$(DEPDIR)/PowerTransform1D.Plo \
./$(DEPDIR)/ProductSymmetricBetaNDCdf.Plo \
./$(DEPDIR)/QuadraticOrthoPolyND.Plo \
./$(DEPDIR)/QuantileTable1D.Plo ./$(DEPDIR)/RatioOfNormals.Plo \
./$(DEPDIR)/ResponseMatrix.Plo \
./$(DEPDIR)/RightCensoredDistribution.Plo \
./$(DEPDIR)/SbMomentsBigGamma.Plo \
./$(DEPDIR)/SbMomentsCalculator.Plo \
./$(DEPDIR)/ScalableGaussND.Plo \
./$(DEPDIR)/SequentialCopulaSmoother.Plo \
./$(DEPDIR)/SequentialGroupedCopulaSmoother.Plo \
./$(DEPDIR)/SequentialPolyFilterND.Plo \
./$(DEPDIR)/SeriesCGF1D.Plo ./$(DEPDIR)/SineGOFTest1D.Plo \
./$(DEPDIR)/SinhAsinhTransform1D.Plo \
./$(DEPDIR)/SmoothCDGOFTest1D.Plo \
./$(DEPDIR)/SmoothedEMUnfold1D.Plo \
./$(DEPDIR)/SmoothedEMUnfoldND.Plo \
./$(DEPDIR)/StatAccumulator.Plo \
./$(DEPDIR)/StatAccumulatorArr.Plo \
./$(DEPDIR)/StatAccumulatorPair.Plo ./$(DEPDIR)/StatUtils.Plo \
./$(DEPDIR)/StorableMultivariateFunctor.Plo \
./$(DEPDIR)/StorableMultivariateFunctorReader.Plo \
./$(DEPDIR)/SymbetaParams1D.Plo \
./$(DEPDIR)/TransformedDistribution1D.Plo \
./$(DEPDIR)/TruncatedDistribution1D.Plo \
./$(DEPDIR)/TwoDistros1DFunctors.Plo \
./$(DEPDIR)/UGaussConvolution1D.Plo \
./$(DEPDIR)/UnbinnedGOFTest1DFactory.Plo \
./$(DEPDIR)/UnbinnedGOFTests1D.Plo \
./$(DEPDIR)/UnfoldingBandwidthScanner1D.Plo \
./$(DEPDIR)/UnfoldingBandwidthScannerND.Plo \
./$(DEPDIR)/UnfoldingFilterNDReader.Plo \
./$(DEPDIR)/UnitMapInterpolationND.Plo \
./$(DEPDIR)/VariableBandwidthSmoother1D.Plo \
./$(DEPDIR)/VerticallyInterpolatedDistribution1D.Plo \
./$(DEPDIR)/WeightTableFilter1DBuilder.Plo \
./$(DEPDIR)/WeightedStatAccumulator.Plo \
./$(DEPDIR)/WeightedStatAccumulatorPair.Plo \
./$(DEPDIR)/amiseOptimalBandwidth.Plo \
./$(DEPDIR)/bivariateChiSquare.Plo \
./$(DEPDIR)/buildInterpolatedHelpers.Plo \
./$(DEPDIR)/continuousDegreeTaper.Plo \
./$(DEPDIR)/convertAxis.Plo \
./$(DEPDIR)/correctDensityEstimateGHU.Plo \
./$(DEPDIR)/distributionReadError.Plo \
./$(DEPDIR)/distro1DStats.Plo ./$(DEPDIR)/fitSbParameters.Plo \
./$(DEPDIR)/gaussianResponseMatrix.Plo \
./$(DEPDIR)/johnsonIntegral.Plo \
./$(DEPDIR)/johnsonTransform.Plo \
./$(DEPDIR)/likelihoodStatisticCumulants.Plo \
./$(DEPDIR)/logLikelihoodPeak.Plo ./$(DEPDIR)/lorpeMise1D.Plo \
./$(DEPDIR)/make_UnbinnedGOFTest1D.Plo \
./$(DEPDIR)/multinomialCovariance1D.Plo \
./$(DEPDIR)/neymanPearsonWindow1D.Plo \
./$(DEPDIR)/randomOrthogonalMatrix.Plo \
./$(DEPDIR)/saddlepointDistribution1D.Plo \
./$(DEPDIR)/scanMultivariateDensityAsWeight.Plo \
./$(DEPDIR)/scanSymmetricDensityAsWeight.Plo \
./$(DEPDIR)/scannedKSDistance.Plo \
./$(DEPDIR)/solveForLOrPEWeights.Plo \
./$(DEPDIR)/statUncertainties.Plo \
./$(DEPDIR)/volumeDensityFromBinnedRadial.Plo
am__mv = mv -f
CXXCOMPILE = $(CXX) $(DEFS) $(DEFAULT_INCLUDES) $(INCLUDES) \
$(AM_CPPFLAGS) $(CPPFLAGS) $(AM_CXXFLAGS) $(CXXFLAGS)
LTCXXCOMPILE = $(LIBTOOL) $(AM_V_lt) --tag=CXX $(AM_LIBTOOLFLAGS) \
$(LIBTOOLFLAGS) --mode=compile $(CXX) $(DEFS) \
$(DEFAULT_INCLUDES) $(INCLUDES) $(AM_CPPFLAGS) $(CPPFLAGS) \
$(AM_CXXFLAGS) $(CXXFLAGS)
AM_V_CXX = $(am__v_CXX_@AM_V@)
am__v_CXX_ = $(am__v_CXX_@AM_DEFAULT_V@)
am__v_CXX_0 = @echo " CXX " $@;
am__v_CXX_1 =
CXXLD = $(CXX)
CXXLINK = $(LIBTOOL) $(AM_V_lt) --tag=CXX $(AM_LIBTOOLFLAGS) \
$(LIBTOOLFLAGS) --mode=link $(CXXLD) $(AM_CXXFLAGS) \
$(CXXFLAGS) $(AM_LDFLAGS) $(LDFLAGS) -o $@
AM_V_CXXLD = $(am__v_CXXLD_@AM_V@)
am__v_CXXLD_ = $(am__v_CXXLD_@AM_DEFAULT_V@)
am__v_CXXLD_0 = @echo " CXXLD " $@;
am__v_CXXLD_1 =
SOURCES = $(libstat_la_SOURCES)
DIST_SOURCES = $(libstat_la_SOURCES)
am__can_run_installinfo = \
case $$AM_UPDATE_INFO_DIR in \
n|no|NO) false;; \
*) (install-info --version) >/dev/null 2>&1;; \
esac
am__vpath_adj_setup = srcdirstrip=`echo "$(srcdir)" | sed 's|.|.|g'`;
am__vpath_adj = case $$p in \
$(srcdir)/*) f=`echo "$$p" | sed "s|^$$srcdirstrip/||"`;; \
*) f=$$p;; \
esac;
am__strip_dir = f=`echo $$p | sed -e 's|^.*/||'`;
am__install_max = 40
am__nobase_strip_setup = \
srcdirstrip=`echo "$(srcdir)" | sed 's/[].[^$$\\*|]/\\\\&/g'`
am__nobase_strip = \
for p in $$list; do echo "$$p"; done | sed -e "s|$$srcdirstrip/||"
am__nobase_list = $(am__nobase_strip_setup); \
for p in $$list; do echo "$$p $$p"; done | \
sed "s| $$srcdirstrip/| |;"' / .*\//!s/ .*/ ./; s,\( .*\)/[^/]*$$,\1,' | \
$(AWK) 'BEGIN { files["."] = "" } { files[$$2] = files[$$2] " " $$1; \
if (++n[$$2] == $(am__install_max)) \
{ print $$2, files[$$2]; n[$$2] = 0; files[$$2] = "" } } \
END { for (dir in files) print dir, files[dir] }'
am__base_list = \
sed '$$!N;$$!N;$$!N;$$!N;$$!N;$$!N;$$!N;s/\n/ /g' | \
sed '$$!N;$$!N;$$!N;$$!N;s/\n/ /g'
am__uninstall_files_from_dir = { \
test -z "$$files" \
|| { test ! -d "$$dir" && test ! -f "$$dir" && test ! -r "$$dir"; } \
|| { echo " ( cd '$$dir' && rm -f" $$files ")"; \
$(am__cd) "$$dir" && rm -f $$files; }; \
}
am__installdirs = "$(DESTDIR)$(includedir)"
HEADERS = $(include_HEADERS)
am__extra_recursive_targets = python-recursive
am__tagged_files = $(HEADERS) $(SOURCES) $(TAGS_FILES) $(LISP)
# Read a list of newline-separated strings from the standard input,
# and print each of them once, without duplicates. Input order is
# *not* preserved.
am__uniquify_input = $(AWK) '\
BEGIN { nonempty = 0; } \
{ items[$$0] = 1; nonempty = 1; } \
END { if (nonempty) { for (i in items) print i; }; } \
'
# Make sure the list of sources is unique. This is necessary because,
# e.g., the same source file might be shared among _SOURCES variables
# for different programs/libraries.
am__define_uniq_tagged_files = \
list='$(am__tagged_files)'; \
unique=`for i in $$list; do \
if test -f "$$i"; then echo $$i; else echo $(srcdir)/$$i; fi; \
done | $(am__uniquify_input)`
am__DIST_COMMON = $(srcdir)/Makefile.in $(top_srcdir)/depcomp
DISTFILES = $(DIST_COMMON) $(DIST_SOURCES) $(TEXINFOS) $(EXTRA_DIST)
ACLOCAL = @ACLOCAL@
AMTAR = @AMTAR@
AM_DEFAULT_VERBOSITY = @AM_DEFAULT_VERBOSITY@
AR = @AR@
AUTOCONF = @AUTOCONF@
AUTOHEADER = @AUTOHEADER@
AUTOMAKE = @AUTOMAKE@
AWK = @AWK@
CC = @CC@
CCDEPMODE = @CCDEPMODE@
CFLAGS = @CFLAGS@
CPPFLAGS = @CPPFLAGS@
CSCOPE = @CSCOPE@
CTAGS = @CTAGS@
CXX = @CXX@
CXXCPP = @CXXCPP@
CXXDEPMODE = @CXXDEPMODE@
CXXFLAGS = @CXXFLAGS@
CYGPATH_W = @CYGPATH_W@
DEFS = @DEFS@
DEPDIR = @DEPDIR@
DEPS_CFLAGS = @DEPS_CFLAGS@
DEPS_LIBS = @DEPS_LIBS@
DLLTOOL = @DLLTOOL@
DSYMUTIL = @DSYMUTIL@
DUMPBIN = @DUMPBIN@
ECHO_C = @ECHO_C@
ECHO_N = @ECHO_N@
ECHO_T = @ECHO_T@
EGREP = @EGREP@
ETAGS = @ETAGS@
EXEEXT = @EXEEXT@
F77 = @F77@
FFLAGS = @FFLAGS@
FGREP = @FGREP@
FLIBS = @FLIBS@
GREP = @GREP@
INSTALL = @INSTALL@
INSTALL_DATA = @INSTALL_DATA@
INSTALL_PROGRAM = @INSTALL_PROGRAM@
INSTALL_SCRIPT = @INSTALL_SCRIPT@
INSTALL_STRIP_PROGRAM = @INSTALL_STRIP_PROGRAM@
LD = @LD@
LDFLAGS = @LDFLAGS@
LIBOBJS = @LIBOBJS@
LIBS = @LIBS@
LIBTOOL = @LIBTOOL@
LIPO = @LIPO@
LN_S = @LN_S@
LTLIBOBJS = @LTLIBOBJS@
LT_SYS_LIBRARY_PATH = @LT_SYS_LIBRARY_PATH@
MAKEINFO = @MAKEINFO@
MANIFEST_TOOL = @MANIFEST_TOOL@
MKDIR_P = @MKDIR_P@
NM = @NM@
NMEDIT = @NMEDIT@
OBJDUMP = @OBJDUMP@
OBJEXT = @OBJEXT@
OTOOL = @OTOOL@
OTOOL64 = @OTOOL64@
PACKAGE = @PACKAGE@
PACKAGE_BUGREPORT = @PACKAGE_BUGREPORT@
PACKAGE_NAME = @PACKAGE_NAME@
PACKAGE_STRING = @PACKAGE_STRING@
PACKAGE_TARNAME = @PACKAGE_TARNAME@
PACKAGE_URL = @PACKAGE_URL@
PACKAGE_VERSION = @PACKAGE_VERSION@
PATH_SEPARATOR = @PATH_SEPARATOR@
PKG_CONFIG = @PKG_CONFIG@
PKG_CONFIG_LIBDIR = @PKG_CONFIG_LIBDIR@
PKG_CONFIG_PATH = @PKG_CONFIG_PATH@
RANLIB = @RANLIB@
SED = @SED@
SET_MAKE = @SET_MAKE@
SHELL = @SHELL@
STRIP = @STRIP@
VERSION = @VERSION@
abs_builddir = @abs_builddir@
abs_srcdir = @abs_srcdir@
abs_top_builddir = @abs_top_builddir@
abs_top_srcdir = @abs_top_srcdir@
ac_ct_AR = @ac_ct_AR@
ac_ct_CC = @ac_ct_CC@
ac_ct_CXX = @ac_ct_CXX@
ac_ct_DUMPBIN = @ac_ct_DUMPBIN@
ac_ct_F77 = @ac_ct_F77@
am__include = @am__include@
am__leading_dot = @am__leading_dot@
am__quote = @am__quote@
am__tar = @am__tar@
am__untar = @am__untar@
bindir = @bindir@
build = @build@
build_alias = @build_alias@
build_cpu = @build_cpu@
build_os = @build_os@
build_vendor = @build_vendor@
builddir = @builddir@
datadir = @datadir@
datarootdir = @datarootdir@
docdir = @docdir@
dvidir = @dvidir@
exec_prefix = @exec_prefix@
host = @host@
host_alias = @host_alias@
host_cpu = @host_cpu@
host_os = @host_os@
host_vendor = @host_vendor@
htmldir = @htmldir@
includedir = ${prefix}/include/npstat/stat
infodir = @infodir@
install_sh = @install_sh@
libdir = @libdir@
libexecdir = @libexecdir@
localedir = @localedir@
localstatedir = @localstatedir@
mandir = @mandir@
mkdir_p = @mkdir_p@
oldincludedir = @oldincludedir@
pdfdir = @pdfdir@
prefix = @prefix@
program_transform_name = @program_transform_name@
psdir = @psdir@
runstatedir = @runstatedir@
sbindir = @sbindir@
sharedstatedir = @sharedstatedir@
srcdir = @srcdir@
sysconfdir = @sysconfdir@
target_alias = @target_alias@
top_build_prefix = @top_build_prefix@
top_builddir = @top_builddir@
top_srcdir = @top_srcdir@
AM_CPPFLAGS = -I@top_srcdir@/ $(DEPS_CFLAGS)
noinst_LTLIBRARIES = libstat.la
libstat_la_SOURCES = AbsDistribution1D.cc AbsUnfoldND.cc AbsKDE1DKernel.cc \
AbsDistributionND.cc amiseOptimalBandwidth.cc CompositeDistribution1D.cc \
CompositeDistributionND.cc CopulaInterpolationND.cc SymbetaParams1D.cc \
Distribution1DFactory.cc Distribution1DReader.cc DistributionNDReader.cc \
Distributions1D.cc DistributionsND.cc CrossCovarianceAccumulator.cc \
fitSbParameters.cc StatAccumulatorArr.cc HistoAxis.cc ResponseMatrix.cc \
InterpolatedDistribution1D.cc JohnsonCurves.cc JohnsonKDESmoother.cc \
LocalPolyFilter1D.cc logLikelihoodPeak.cc PolyFilterCollection1D.cc \
SbMomentsBigGamma.cc SbMomentsCalculator.cc gaussianResponseMatrix.cc \
SequentialCopulaSmoother.cc SequentialPolyFilterND.cc StatAccumulator.cc \
UnitMapInterpolationND.cc WeightedStatAccumulator.cc AbsNtuple.cc \
QuadraticOrthoPolyND.cc NMCombinationSequencer.cc Filter1DBuilders.cc \
StatAccumulatorPair.cc GridRandomizer.cc ConstantBandwidthSmoother1D.cc \
GaussianMixture1D.cc HistoNDCdf.cc NUHistoAxis.cc AllSymbetaParams1D.cc \
distributionReadError.cc WeightedStatAccumulatorPair.cc AbsUnfold1D.cc \
ProductSymmetricBetaNDCdf.cc DualHistoAxis.cc multinomialCovariance1D.cc \
StorableMultivariateFunctor.cc StorableMultivariateFunctorReader.cc \
TruncatedDistribution1D.cc neymanPearsonWindow1D.cc AsinhTransform1D.cc \
LOrPEMarginalSmoother.cc LeftCensoredDistribution.cc QuantileTable1D.cc \
RightCensoredDistribution.cc AbsDiscreteDistribution1D.cc convertAxis.cc \
DiscreteDistribution1DReader.cc DiscreteDistributions1D.cc lorpeMise1D.cc \
BernsteinFilter1DBuilder.cc BetaFilter1DBuilder.cc AbsFilter1DBuilder.cc \
continuousDegreeTaper.cc RatioOfNormals.cc AbsCVCopulaSmoother.cc \
DensityScan1D.cc BoundaryHandling.cc SmoothedEMUnfold1D.cc Copulas.cc \
PearsonsChiSquared.cc BinnedKSTest1D.cc MultiscaleEMUnfold1D.cc \
AbsBinnedComparison1D.cc BinnedADTest1D.cc LocalPolyFilter1DReader.cc \
MemoizingSymbetaFilterProvider.cc UGaussConvolution1D.cc BinSummary.cc \
SmoothedEMUnfoldND.cc UnfoldingFilterNDReader.cc AbsUnfoldingFilterND.cc \
UnfoldingBandwidthScannerND.cc DistributionMix1D.cc ScalableGaussND.cc \
InterpolatedDistro1D1P.cc AbsDistributionTransform1D.cc LogTransform1D.cc \
DistributionTransform1DReader.cc TransformedDistribution1D.cc AbsCGF1D.cc \
WeightTableFilter1DBuilder.cc VerticallyInterpolatedDistribution1D.cc \
LocalMultiFilter1D.cc LogRatioTransform1D.cc IdentityTransform1D.cc \
VariableBandwidthSmoother1D.cc AbsMarginalSmootherBase.cc OSDE1D.cc \
buildInterpolatedHelpers.cc GridInterpolatedDistribution.cc StatUtils.cc \
AbsCopulaSmootherBase.cc BernsteinCopulaSmoother.cc distro1DStats.cc \
SequentialGroupedCopulaSmoother.cc UnfoldingBandwidthScanner1D.cc \
InterpolatedDistro1DNP.cc volumeDensityFromBinnedRadial.cc \
statUncertainties.cc LocationScaleFamily1D.cc SinhAsinhTransform1D.cc \
KDE1DHOSymbetaKernel.cc EdgeworthSeriesMethod.cc scannedKSDistance.cc \
EdgeworthSeries1D.cc DeltaMixture1D.cc LikelihoodStatisticType.cc \
likelihoodStatisticCumulants.cc GaussianMixtureEntry.cc SeriesCGF1D.cc \
correctDensityEstimateGHU.cc ComparisonDistribution1D.cc \
DistributionMixND.cc DiscreteGauss1DBuilder.cc DensityOrthoPoly1D.cc \
scanMultivariateDensityAsWeight.cc scanSymmetricDensityAsWeight.cc \
DiscreteGaussCopulaSmoother.cc ExpTiltedDistribution1D.cc \
saddlepointDistribution1D.cc MatrixFilter1DBuilder.cc SineGOFTest1D.cc \
PolynomialDistro1D.cc AbsUnbinnedGOFTest1D.cc OrthoPolyGOFTest1D.cc \
UnbinnedGOFTests1D.cc UnbinnedGOFTest1DFactory.cc SmoothCDGOFTest1D.cc \
LOrPE1DSymbetaKernel.cc FoldedDistribution1D.cc solveForLOrPEWeights.cc \
bivariateChiSquare.cc EllipticalDistribution.cc PowerTransform1D.cc \
PowerHalfCauchy1D.cc PowerRatio1D.cc EllipticalDistributions.cc \
make_UnbinnedGOFTest1D.cc AbsTwoDistros1DFunctor.cc johnsonTransform.cc \
TwoDistros1DFunctors.cc AbsSmoothGOFTest1D.cc LocScaleTransform1D.cc \
LognormalTransform1D.cc JohnsonOrthoPoly1D.cc johnsonIntegral.cc \
randomOrthogonalMatrix.cc LegendreDistro1D.cc CdfTransform1D.cc \
- ChebyshevDistro1D.cc KernelSensitivityCalculator.cc NeymanOSDE1D.cc
+ ChebyshevDistro1D.cc KernelSensitivityCalculator.cc NeymanOSDE1D.cc \
+ NeymanOSDE1DResult.cc
include_HEADERS = AbsBandwidthCV.hh \
AbsBandwidthGCV.hh \
AbsBinnedComparison1D.hh \
AbsBinnedComparison1D.icc \
AbsCGF1D.hh \
AbsCompositeDistroBuilder.hh \
AbsCompositeDistroBuilder.icc \
AbsCopulaSmootherBase.hh \
AbsCopulaSmootherBase.icc \
AbsCVCopulaSmoother.hh \
AbsDiscreteDistribution1D.hh \
AbsDistribution1D.hh \
AbsDistribution1D.icc \
AbsDistributionND.hh \
AbsDistributionND.icc \
AbsDistributionTransform1D.hh \
AbsDistro1DBuilder.hh \
AbsDistro1DBuilder.icc \
AbsFilter1DBuilder.hh \
AbsInterpolatedDistribution1D.hh \
AbsInterpolationAlgoND.hh \
AbsKDE1DKernel.hh \
AbsKDE1DKernel.icc \
AbsLossCalculator.hh \
AbsMarginalSmootherBase.hh \
AbsMarginalSmootherBase.icc \
AbsNtuple.hh \
AbsNtuple.icc \
AbsPolyFilter1D.hh \
AbsPolyFilterND.hh \
AbsResponseBoxBuilder.hh \
AbsResponseIntervalBuilder.hh \
AbsSmoothGOFTest1D.hh \
AbsSmoothGOFTest1D.icc \
AbsSymbetaFilterProvider.hh \
AbsTwoDistros1DFunctor.hh \
AbsUnbinnedGOFTest1D.hh \
AbsUnfold1D.hh \
AbsUnfoldingFilterND.hh \
AbsUnfoldND.hh \
AllSymbetaParams1D.hh \
amiseOptimalBandwidth.hh \
amiseOptimalBandwidth.icc \
ArchivedNtuple.hh \
ArchivedNtuple.icc \
ArrayProjectors.hh \
ArrayProjectors.icc \
arrayStats.hh \
arrayStats.icc \
AsinhTransform1D.hh \
BandwidthCVLeastSquares1D.hh \
BandwidthCVLeastSquares1D.icc \
BandwidthCVLeastSquaresND.hh \
BandwidthCVLeastSquaresND.icc \
BandwidthCVPseudoLogli1D.hh \
BandwidthCVPseudoLogli1D.icc \
BandwidthCVPseudoLogliND.hh \
BandwidthCVPseudoLogliND.icc \
BandwidthGCVLeastSquares1D.hh \
BandwidthGCVLeastSquares1D.icc \
BandwidthGCVLeastSquaresND.hh \
BandwidthGCVLeastSquaresND.icc \
BandwidthGCVPseudoLogli1D.hh \
BandwidthGCVPseudoLogli1D.icc \
BandwidthGCVPseudoLogliND.hh \
BandwidthGCVPseudoLogliND.icc \
BernsteinCopulaSmoother.hh \
BernsteinFilter1DBuilder.hh \
betaKernelsBandwidth.hh \
betaKernelsBandwidth.icc \
BetaFilter1DBuilder.hh \
BinnedADTest1D.hh \
BinnedKSTest1D.hh \
BinSummary.hh \
BinSummary.icc \
bivariateChiSquare.hh \
BoundaryHandling.hh \
BoundaryMethod.hh \
buildInterpolatedCompositeDistroND.hh \
buildInterpolatedCompositeDistroND.icc \
buildInterpolatedDistro1DNP.hh \
buildInterpolatedDistro1DNP.icc \
buildInterpolatedHelpers.hh \
CdfTransform1D.hh \
CensoredQuantileRegression.hh \
CensoredQuantileRegression.icc \
ChebyshevDistro1D.hh \
CircularBuffer.hh \
CircularBuffer.icc \
Column.hh \
Column.icc \
ComparisonDistribution1D.hh \
CompositeDistribution1D.hh \
CompositeDistributionND.hh \
CompositeDistributionND.icc \
CompositeDistros1D.hh \
ConstantBandwidthSmoother1D.hh \
ConstantBandwidthSmootherND.hh \
ConstantBandwidthSmootherND.icc \
continuousDegreeTaper.hh \
convertAxis.hh \
CopulaInterpolationND.hh \
Copulas.hh \
correctDensityEstimateGHU.hh \
CrossCovarianceAccumulator.hh \
CrossCovarianceAccumulator.icc \
cumulantConversion.hh \
cumulantConversion.icc \
cumulantUncertainties.hh \
cumulantUncertainties.icc \
CVCopulaSmoother.hh \
CVCopulaSmoother.icc \
dampedNewtonForNeymanOSDE1D.hh \
DeltaMixture1D.hh \
DeltaMixture1D.icc \
DensityAveScanND.hh \
DensityOrthoPoly1D.hh \
DensityScan1D.hh \
DensityScanND.hh \
DiscreteDistribution1DReader.hh \
DiscreteDistributions1D.hh \
DiscreteGauss1DBuilder.hh \
DiscreteGaussCopulaSmoother.hh \
discretizationErrorND.hh \
Distribution1DFactory.hh \
Distribution1DReader.hh \
DistributionTransform1DReader.hh \
DistributionMix1D.hh \
DistributionMixND.hh \
DistributionNDReader.hh \
Distributions1D.hh \
Distributions1D.icc \
DistributionsND.hh \
DistributionsND.icc \
distributionReadError.hh \
distro1DStats.hh \
DualHistoAxis.hh \
DummyCompositeDistroBuilder.hh \
DummyDistro1DBuilder.hh \
DummyResponseBoxBuilder.hh \
DummyResponseIntervalBuilder.hh \
EdgeworthSeries1D.hh \
EdgeworthSeriesMethod.hh \
EllipticalDistribution.hh \
EllipticalDistributions.hh \
empiricalCopula.hh \
empiricalCopulaHisto.hh \
empiricalCopulaHisto.icc \
empiricalCopula.icc \
ExpTiltedDistribution1D.hh \
fillHistoFromText.hh \
fillHistoFromText.icc \
Filter1DBuilders.hh \
FitUtils.hh \
FitUtils.icc \
FoldedDistribution1D.hh \
GaussianMixtureEntry.hh \
GaussianMixture1D.hh \
gaussianResponseMatrix.hh \
GCVCopulaSmoother.hh \
GCVCopulaSmoother.icc \
gradientDescentForNeymanOSDE1D.hh \
griddedRobustRegression.hh \
griddedRobustRegression.icc \
GriddedRobustRegressionStop.hh \
GridInterpolatedDistribution.hh \
GridRandomizer.hh \
HistoAxis.hh \
HistoND.hh \
HistoND.icc \
HistoNDCdf.hh \
HistoNDFunctorInstances.hh \
histoStats.hh \
histoStats.icc \
histoUtils.hh \
histoUtils.icc \
IdentityTransform1D.hh \
InMemoryNtuple.hh \
InMemoryNtuple.icc \
InterpolatedDistribution1D.hh \
InterpolatedDistro1D1P.hh \
InterpolatedDistro1DNP.hh \
interpolateHistoND.hh \
interpolateHistoND.icc \
InterpolationFunctorInstances.hh \
JohnsonCurves.hh \
johnsonIntegral.hh \
JohnsonKDESmoother.hh \
JohnsonOrthoPoly1D.hh \
johnsonTransform.hh \
KDE1D.hh \
KDE1DCV.hh \
KDE1DHOSymbetaKernel.hh \
KDECopulaSmoother.hh \
KDECopulaSmoother.icc \
KDEGroupedCopulaSmoother.hh \
KDEGroupedCopulaSmoother.icc \
KDEFilterND.hh \
KDEFilterND.icc \
kendallsTau.hh \
kendallsTau.icc \
KernelSensitivityCalculator.hh \
KernelSensitivityCalculator.icc \
LeftCensoredDistribution.hh \
LegendreDistro1D.hh \
likelihoodStatisticCumulants.hh \
LikelihoodStatisticType.hh \
LocalLogisticRegression.hh \
LocalLogisticRegression.icc \
LocalMultiFilter1D.hh \
LocalMultiFilter1D.icc \
LocalPolyFilter1D.hh \
LocalPolyFilter1D.icc \
LocalPolyFilter1DReader.hh \
LocalPolyFilterND.hh \
LocalPolyFilterND.icc \
LocalQuadraticLeastSquaresND.hh \
LocalQuadraticLeastSquaresND.icc \
LocalQuantileRegression.hh \
LocalQuantileRegression.icc \
LocationScaleFamily1D.hh \
LocationScaleTransform1.hh \
LocationScaleTransform1.icc \
LocScaleTransform1D.hh \
logLikelihoodPeak.hh \
LognormalTransform1D.hh \
LogRatioTransform1D.hh \
LogTransform1D.hh \
LOrPE1D.hh \
LOrPE1D.icc \
LOrPE1DCV.hh \
LOrPE1DCVResult.hh \
LOrPE1DFixedDegreeCVPicker.hh \
LOrPE1DFixedDegreeCVRunner.hh \
LOrPE1DFixedDegreeCVScanner.hh \
LOrPE1DSymbetaKernel.hh \
LOrPE1DSymbetaKernel.icc \
LOrPE1DVariableDegreeCVRunner.hh \
LOrPE1DVariableDegreeCVPicker.hh \
LOrPECopulaSmoother.hh \
LOrPECopulaSmoother.icc \
LOrPEGroupedCopulaSmoother.hh \
LOrPEGroupedCopulaSmoother.icc \
LOrPEMarginalSmoother.hh \
LOrPEWeightsLocalConvergence.hh \
lorpeBackgroundCVDensity1D.hh \
lorpeBackgroundCVDensity1D.icc \
lorpeBackground1D.hh \
lorpeBackground1D.icc \
lorpeMise1D.hh \
lorpeSmooth1D.hh \
lorpeSmooth1D.icc \
make_UnbinnedGOFTest1D.hh \
MatrixFilter1DBuilder.hh \
MemoizingSymbetaFilterProvider.hh \
mergeTwoHistos.hh \
mergeTwoHistos.icc \
mirrorWeight.hh \
ModulatedDistribution1D.hh \
MultiscaleEMUnfold1D.hh \
multinomialCovariance1D.hh \
MultivariateSumAccumulator.hh \
MultivariateSumsqAccumulator.hh \
MultivariateSumsqAccumulator.icc \
MultivariateWeightedSumAccumulator.hh \
MultivariateWeightedSumsqAccumulator.hh \
MultivariateWeightedSumsqAccumulator.icc \
NeymanOSDE1DConvergence.hh \
NeymanOSDE1DResult.hh \
NeymanOSDE1D.hh \
NeymanOSDE1D.icc \
neymanPearsonWindow1D.hh \
NMCombinationSequencer.hh \
NonparametricCompositeBuilder.hh \
NonparametricCompositeBuilder.icc \
NonparametricDistro1DBuilder.hh \
NonparametricDistro1DBuilder.icc \
NtHistoFill.hh \
NtNtupleFill.hh \
NtRectangularCut.hh \
NtRectangularCut.icc \
NtupleBuffer.hh \
NtupleBuffer.icc \
NtupleRecordTypes.hh \
NtupleRecordTypesFwd.hh \
NtupleReference.hh \
ntupleStats.hh \
NUHistoAxis.hh \
OrderedPointND.hh \
OrderedPointND.icc \
orthoPoly1DVProducts.hh \
orthoPoly1DVProducts.icc \
OrthoPolyGOFTest1D.hh \
OrthoPolyGOFTest1D.icc \
OSDE1D.hh \
OSDE1D.icc \
PearsonsChiSquared.hh \
polyExpectation.hh \
polyExpectation.icc \
PolyFilterCollection1D.hh \
PolynomialDistro1D.hh \
PowerHalfCauchy1D.hh \
PowerRatio1D.hh \
PowerTransform1D.hh \
productResponseMatrix.hh \
productResponseMatrix.icc \
ProductSymmetricBetaNDCdf.hh \
QuadraticOrthoPolyND.hh \
QuadraticOrthoPolyND.icc \
QuantileRegression1D.hh \
QuantileRegression1D.icc \
QuantileTable1D.hh \
randomHistoFill1D.hh \
randomHistoFill1D.icc \
randomHistoFillND.hh \
randomHistoFillND.icc \
randomOrthogonalMatrix.hh \
randomSearchForNeymanOSDE1D.hh \
RatioOfNormals.hh \
RatioResponseBoxBuilder.hh \
RatioResponseBoxBuilder.icc \
RatioResponseIntervalBuilder.hh \
RatioResponseIntervalBuilder.icc \
ResponseMatrix.hh \
RightCensoredDistribution.hh \
saddlepointDistribution1D.hh \
SampleAccumulator.hh \
SampleAccumulator.icc \
sampleDistro1DWithWeight.hh \
SbMomentsCalculator.hh \
ScalableGaussND.hh \
scannedKSDistance.hh \
scanMultivariateDensityAsWeight.hh \
scanSymmetricDensityAsWeight.hh \
semiMixLocalLogLikelihood.hh \
SequentialCopulaSmoother.hh \
SequentialCopulaSmoother.icc \
SequentialGroupedCopulaSmoother.hh \
SequentialGroupedCopulaSmoother.icc \
SequentialPolyFilterND.hh \
SequentialPolyFilterND.icc \
SeriesCGF1D.hh \
SineGOFTest1D.hh \
SineGOFTest1D.icc \
SinhAsinhTransform1D.hh \
SmoothCDGOFTest1D.hh \
SmoothCDGOFTest1D.icc \
SmoothedEMUnfold1D.hh \
SmoothedEMUnfoldND.hh \
SmoothGOFTest1D.hh \
SmoothGOFTest1D.icc \
solveForLOrPEWeights.hh \
spearmansRho.hh \
spearmansRho.icc \
StatAccumulator.hh \
StatAccumulatorArr.hh \
StatAccumulatorPair.hh \
statUncertainties.hh \
StatUtils.hh \
StatUtils.icc \
StorableHistoNDFunctor.hh \
StorableHistoNDFunctor.icc \
StorableInterpolationFunctor.hh \
StorableInterpolationFunctor.icc \
StorableMultivariateFunctor.hh \
StorableMultivariateFunctorReader.hh \
SymbetaParams1D.hh \
TransformedDistribution1D.hh \
TruncatedDistribution1D.hh \
TwoDistros1DFunctors.hh \
TwoPointsLTSLoss.hh \
TwoPointsLTSLoss.icc \
UGaussConvolution1D.hh \
UnbinnedGOFTests1D.hh \
UnbinnedGOFTests1D.icc \
UnbinnedGOFTest1DFactory.hh \
UnfoldingBandwidthScanner1D.hh \
UnfoldingBandwidthScannerND.hh \
UnfoldingFilterNDReader.hh \
UnitMapInterpolationND.hh \
variableBandwidthSmooth1D.hh \
variableBandwidthSmooth1D.icc \
VariableBandwidthSmoother1D.hh \
VerticallyInterpolatedDistribution1D.hh \
volumeDensityFromBinnedRadial.hh \
weightedCopulaHisto.hh \
weightedCopulaHisto.icc \
WeightedDistro1DPtr.hh \
WeightedLTSLoss.hh \
WeightedLTSLoss.icc \
WeightedSampleAccumulator.hh \
WeightedSampleAccumulator.icc \
WeightedStatAccumulator.hh \
WeightedStatAccumulatorPair.hh \
WeightTableFilter1DBuilder.hh
EXTRA_DIST = 00README.txt npstat_doxy.hh
all: all-am
.SUFFIXES:
.SUFFIXES: .cc .lo .o .obj
$(srcdir)/Makefile.in: $(srcdir)/Makefile.am $(am__configure_deps)
@for dep in $?; do \
case '$(am__configure_deps)' in \
*$$dep*) \
( cd $(top_builddir) && $(MAKE) $(AM_MAKEFLAGS) am--refresh ) \
&& { if test -f $@; then exit 0; else break; fi; }; \
exit 1;; \
esac; \
done; \
echo ' cd $(top_srcdir) && $(AUTOMAKE) --foreign npstat/stat/Makefile'; \
$(am__cd) $(top_srcdir) && \
$(AUTOMAKE) --foreign npstat/stat/Makefile
Makefile: $(srcdir)/Makefile.in $(top_builddir)/config.status
@case '$?' in \
*config.status*) \
cd $(top_builddir) && $(MAKE) $(AM_MAKEFLAGS) am--refresh;; \
*) \
echo ' cd $(top_builddir) && $(SHELL) ./config.status $(subdir)/$@ $(am__maybe_remake_depfiles)'; \
cd $(top_builddir) && $(SHELL) ./config.status $(subdir)/$@ $(am__maybe_remake_depfiles);; \
esac;
$(top_builddir)/config.status: $(top_srcdir)/configure $(CONFIG_STATUS_DEPENDENCIES)
cd $(top_builddir) && $(MAKE) $(AM_MAKEFLAGS) am--refresh
$(top_srcdir)/configure: $(am__configure_deps)
cd $(top_builddir) && $(MAKE) $(AM_MAKEFLAGS) am--refresh
$(ACLOCAL_M4): $(am__aclocal_m4_deps)
cd $(top_builddir) && $(MAKE) $(AM_MAKEFLAGS) am--refresh
$(am__aclocal_m4_deps):
clean-noinstLTLIBRARIES:
-test -z "$(noinst_LTLIBRARIES)" || rm -f $(noinst_LTLIBRARIES)
@list='$(noinst_LTLIBRARIES)'; \
locs=`for p in $$list; do echo $$p; done | \
sed 's|^[^/]*$$|.|; s|/[^/]*$$||; s|$$|/so_locations|' | \
sort -u`; \
test -z "$$locs" || { \
echo rm -f $${locs}; \
rm -f $${locs}; \
}
libstat.la: $(libstat_la_OBJECTS) $(libstat_la_DEPENDENCIES) $(EXTRA_libstat_la_DEPENDENCIES)
$(AM_V_CXXLD)$(CXXLINK) $(libstat_la_OBJECTS) $(libstat_la_LIBADD) $(LIBS)
mostlyclean-compile:
-rm -f *.$(OBJEXT)
distclean-compile:
-rm -f *.tab.c
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/AbsBinnedComparison1D.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/AbsCGF1D.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/AbsCVCopulaSmoother.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/AbsCopulaSmootherBase.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/AbsDiscreteDistribution1D.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/AbsDistribution1D.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/AbsDistributionND.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/AbsDistributionTransform1D.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/AbsFilter1DBuilder.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/AbsKDE1DKernel.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/AbsMarginalSmootherBase.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/AbsNtuple.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/AbsSmoothGOFTest1D.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/AbsTwoDistros1DFunctor.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/AbsUnbinnedGOFTest1D.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/AbsUnfold1D.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/AbsUnfoldND.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/AbsUnfoldingFilterND.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/AllSymbetaParams1D.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/AsinhTransform1D.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/BernsteinCopulaSmoother.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/BernsteinFilter1DBuilder.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/BetaFilter1DBuilder.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/BinSummary.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/BinnedADTest1D.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/BinnedKSTest1D.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/BoundaryHandling.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/CdfTransform1D.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/ChebyshevDistro1D.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/ComparisonDistribution1D.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/CompositeDistribution1D.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/CompositeDistributionND.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/ConstantBandwidthSmoother1D.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/CopulaInterpolationND.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/Copulas.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/CrossCovarianceAccumulator.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/DeltaMixture1D.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/DensityOrthoPoly1D.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/DensityScan1D.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/DiscreteDistribution1DReader.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/DiscreteDistributions1D.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/DiscreteGauss1DBuilder.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/DiscreteGaussCopulaSmoother.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/Distribution1DFactory.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/Distribution1DReader.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/DistributionMix1D.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/DistributionMixND.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/DistributionNDReader.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/DistributionTransform1DReader.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/Distributions1D.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/DistributionsND.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/DualHistoAxis.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/EdgeworthSeries1D.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/EdgeworthSeriesMethod.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/EllipticalDistribution.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/EllipticalDistributions.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/ExpTiltedDistribution1D.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/Filter1DBuilders.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/FoldedDistribution1D.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/GaussianMixture1D.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/GaussianMixtureEntry.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/GridInterpolatedDistribution.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/GridRandomizer.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/HistoAxis.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/HistoNDCdf.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/IdentityTransform1D.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/InterpolatedDistribution1D.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/InterpolatedDistro1D1P.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/InterpolatedDistro1DNP.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/JohnsonCurves.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/JohnsonKDESmoother.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/JohnsonOrthoPoly1D.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/KDE1DHOSymbetaKernel.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/KernelSensitivityCalculator.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/LOrPE1DSymbetaKernel.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/LOrPEMarginalSmoother.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/LeftCensoredDistribution.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/LegendreDistro1D.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/LikelihoodStatisticType.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/LocScaleTransform1D.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/LocalMultiFilter1D.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/LocalPolyFilter1D.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/LocalPolyFilter1DReader.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/LocationScaleFamily1D.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/LogRatioTransform1D.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/LogTransform1D.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/LognormalTransform1D.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/MatrixFilter1DBuilder.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/MemoizingSymbetaFilterProvider.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/MultiscaleEMUnfold1D.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/NMCombinationSequencer.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/NUHistoAxis.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/NeymanOSDE1D.Plo@am__quote@ # am--include-marker
+@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/NeymanOSDE1DResult.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/OSDE1D.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/OrthoPolyGOFTest1D.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/PearsonsChiSquared.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/PolyFilterCollection1D.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/PolynomialDistro1D.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/PowerHalfCauchy1D.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/PowerRatio1D.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/PowerTransform1D.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/ProductSymmetricBetaNDCdf.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/QuadraticOrthoPolyND.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/QuantileTable1D.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/RatioOfNormals.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/ResponseMatrix.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/RightCensoredDistribution.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/SbMomentsBigGamma.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/SbMomentsCalculator.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/ScalableGaussND.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/SequentialCopulaSmoother.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/SequentialGroupedCopulaSmoother.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/SequentialPolyFilterND.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/SeriesCGF1D.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/SineGOFTest1D.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/SinhAsinhTransform1D.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/SmoothCDGOFTest1D.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/SmoothedEMUnfold1D.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/SmoothedEMUnfoldND.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/StatAccumulator.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/StatAccumulatorArr.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/StatAccumulatorPair.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/StatUtils.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/StorableMultivariateFunctor.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/StorableMultivariateFunctorReader.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/SymbetaParams1D.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/TransformedDistribution1D.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/TruncatedDistribution1D.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/TwoDistros1DFunctors.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/UGaussConvolution1D.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/UnbinnedGOFTest1DFactory.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/UnbinnedGOFTests1D.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/UnfoldingBandwidthScanner1D.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/UnfoldingBandwidthScannerND.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/UnfoldingFilterNDReader.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/UnitMapInterpolationND.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/VariableBandwidthSmoother1D.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/VerticallyInterpolatedDistribution1D.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/WeightTableFilter1DBuilder.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/WeightedStatAccumulator.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/WeightedStatAccumulatorPair.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/amiseOptimalBandwidth.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/bivariateChiSquare.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/buildInterpolatedHelpers.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/continuousDegreeTaper.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/convertAxis.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/correctDensityEstimateGHU.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/distributionReadError.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/distro1DStats.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/fitSbParameters.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/gaussianResponseMatrix.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/johnsonIntegral.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/johnsonTransform.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/likelihoodStatisticCumulants.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/logLikelihoodPeak.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/lorpeMise1D.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/make_UnbinnedGOFTest1D.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/multinomialCovariance1D.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/neymanPearsonWindow1D.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/randomOrthogonalMatrix.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/saddlepointDistribution1D.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/scanMultivariateDensityAsWeight.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/scanSymmetricDensityAsWeight.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/scannedKSDistance.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/solveForLOrPEWeights.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/statUncertainties.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/volumeDensityFromBinnedRadial.Plo@am__quote@ # am--include-marker
$(am__depfiles_remade):
@$(MKDIR_P) $(@D)
@echo '# dummy' >$@-t && $(am__mv) $@-t $@
am--depfiles: $(am__depfiles_remade)
.cc.o:
@am__fastdepCXX_TRUE@ $(AM_V_CXX)$(CXXCOMPILE) -MT $@ -MD -MP -MF $(DEPDIR)/$*.Tpo -c -o $@ $<
@am__fastdepCXX_TRUE@ $(AM_V_at)$(am__mv) $(DEPDIR)/$*.Tpo $(DEPDIR)/$*.Po
@AMDEP_TRUE@@am__fastdepCXX_FALSE@ $(AM_V_CXX)source='$<' object='$@' libtool=no @AMDEPBACKSLASH@
@AMDEP_TRUE@@am__fastdepCXX_FALSE@ DEPDIR=$(DEPDIR) $(CXXDEPMODE) $(depcomp) @AMDEPBACKSLASH@
@am__fastdepCXX_FALSE@ $(AM_V_CXX@am__nodep@)$(CXXCOMPILE) -c -o $@ $<
.cc.obj:
@am__fastdepCXX_TRUE@ $(AM_V_CXX)$(CXXCOMPILE) -MT $@ -MD -MP -MF $(DEPDIR)/$*.Tpo -c -o $@ `$(CYGPATH_W) '$<'`
@am__fastdepCXX_TRUE@ $(AM_V_at)$(am__mv) $(DEPDIR)/$*.Tpo $(DEPDIR)/$*.Po
@AMDEP_TRUE@@am__fastdepCXX_FALSE@ $(AM_V_CXX)source='$<' object='$@' libtool=no @AMDEPBACKSLASH@
@AMDEP_TRUE@@am__fastdepCXX_FALSE@ DEPDIR=$(DEPDIR) $(CXXDEPMODE) $(depcomp) @AMDEPBACKSLASH@
@am__fastdepCXX_FALSE@ $(AM_V_CXX@am__nodep@)$(CXXCOMPILE) -c -o $@ `$(CYGPATH_W) '$<'`
.cc.lo:
@am__fastdepCXX_TRUE@ $(AM_V_CXX)$(LTCXXCOMPILE) -MT $@ -MD -MP -MF $(DEPDIR)/$*.Tpo -c -o $@ $<
@am__fastdepCXX_TRUE@ $(AM_V_at)$(am__mv) $(DEPDIR)/$*.Tpo $(DEPDIR)/$*.Plo
@AMDEP_TRUE@@am__fastdepCXX_FALSE@ $(AM_V_CXX)source='$<' object='$@' libtool=yes @AMDEPBACKSLASH@
@AMDEP_TRUE@@am__fastdepCXX_FALSE@ DEPDIR=$(DEPDIR) $(CXXDEPMODE) $(depcomp) @AMDEPBACKSLASH@
@am__fastdepCXX_FALSE@ $(AM_V_CXX@am__nodep@)$(LTCXXCOMPILE) -c -o $@ $<
mostlyclean-libtool:
-rm -f *.lo
clean-libtool:
-rm -rf .libs _libs
install-includeHEADERS: $(include_HEADERS)
@$(NORMAL_INSTALL)
@list='$(include_HEADERS)'; test -n "$(includedir)" || list=; \
if test -n "$$list"; then \
echo " $(MKDIR_P) '$(DESTDIR)$(includedir)'"; \
$(MKDIR_P) "$(DESTDIR)$(includedir)" || exit 1; \
fi; \
for p in $$list; do \
if test -f "$$p"; then d=; else d="$(srcdir)/"; fi; \
echo "$$d$$p"; \
done | $(am__base_list) | \
while read files; do \
echo " $(INSTALL_HEADER) $$files '$(DESTDIR)$(includedir)'"; \
$(INSTALL_HEADER) $$files "$(DESTDIR)$(includedir)" || exit $$?; \
done
uninstall-includeHEADERS:
@$(NORMAL_UNINSTALL)
@list='$(include_HEADERS)'; test -n "$(includedir)" || list=; \
files=`for p in $$list; do echo $$p; done | sed -e 's|^.*/||'`; \
dir='$(DESTDIR)$(includedir)'; $(am__uninstall_files_from_dir)
python-local:
ID: $(am__tagged_files)
$(am__define_uniq_tagged_files); mkid -fID $$unique
tags: tags-am
TAGS: tags
tags-am: $(TAGS_DEPENDENCIES) $(am__tagged_files)
set x; \
here=`pwd`; \
$(am__define_uniq_tagged_files); \
shift; \
if test -z "$(ETAGS_ARGS)$$*$$unique"; then :; else \
test -n "$$unique" || unique=$$empty_fix; \
if test $$# -gt 0; then \
$(ETAGS) $(ETAGSFLAGS) $(AM_ETAGSFLAGS) $(ETAGS_ARGS) \
"$$@" $$unique; \
else \
$(ETAGS) $(ETAGSFLAGS) $(AM_ETAGSFLAGS) $(ETAGS_ARGS) \
$$unique; \
fi; \
fi
ctags: ctags-am
CTAGS: ctags
ctags-am: $(TAGS_DEPENDENCIES) $(am__tagged_files)
$(am__define_uniq_tagged_files); \
test -z "$(CTAGS_ARGS)$$unique" \
|| $(CTAGS) $(CTAGSFLAGS) $(AM_CTAGSFLAGS) $(CTAGS_ARGS) \
$$unique
GTAGS:
here=`$(am__cd) $(top_builddir) && pwd` \
&& $(am__cd) $(top_srcdir) \
&& gtags -i $(GTAGS_ARGS) "$$here"
cscopelist: cscopelist-am
cscopelist-am: $(am__tagged_files)
list='$(am__tagged_files)'; \
case "$(srcdir)" in \
[\\/]* | ?:[\\/]*) sdir="$(srcdir)" ;; \
*) sdir=$(subdir)/$(srcdir) ;; \
esac; \
for i in $$list; do \
if test -f "$$i"; then \
echo "$(subdir)/$$i"; \
else \
echo "$$sdir/$$i"; \
fi; \
done >> $(top_builddir)/cscope.files
distclean-tags:
-rm -f TAGS ID GTAGS GRTAGS GSYMS GPATH tags
distdir: $(BUILT_SOURCES)
$(MAKE) $(AM_MAKEFLAGS) distdir-am
distdir-am: $(DISTFILES)
@srcdirstrip=`echo "$(srcdir)" | sed 's/[].[^$$\\*]/\\\\&/g'`; \
topsrcdirstrip=`echo "$(top_srcdir)" | sed 's/[].[^$$\\*]/\\\\&/g'`; \
list='$(DISTFILES)'; \
dist_files=`for file in $$list; do echo $$file; done | \
sed -e "s|^$$srcdirstrip/||;t" \
-e "s|^$$topsrcdirstrip/|$(top_builddir)/|;t"`; \
case $$dist_files in \
*/*) $(MKDIR_P) `echo "$$dist_files" | \
sed '/\//!d;s|^|$(distdir)/|;s,/[^/]*$$,,' | \
sort -u` ;; \
esac; \
for file in $$dist_files; do \
if test -f $$file || test -d $$file; then d=.; else d=$(srcdir); fi; \
if test -d $$d/$$file; then \
dir=`echo "/$$file" | sed -e 's,/[^/]*$$,,'`; \
if test -d "$(distdir)/$$file"; then \
find "$(distdir)/$$file" -type d ! -perm -700 -exec chmod u+rwx {} \;; \
fi; \
if test -d $(srcdir)/$$file && test $$d != $(srcdir); then \
cp -fpR $(srcdir)/$$file "$(distdir)$$dir" || exit 1; \
find "$(distdir)/$$file" -type d ! -perm -700 -exec chmod u+rwx {} \;; \
fi; \
cp -fpR $$d/$$file "$(distdir)$$dir" || exit 1; \
else \
test -f "$(distdir)/$$file" \
|| cp -p $$d/$$file "$(distdir)/$$file" \
|| exit 1; \
fi; \
done
check-am: all-am
check: check-am
all-am: Makefile $(LTLIBRARIES) $(HEADERS)
installdirs:
for dir in "$(DESTDIR)$(includedir)"; do \
test -z "$$dir" || $(MKDIR_P) "$$dir"; \
done
install: install-am
install-exec: install-exec-am
install-data: install-data-am
uninstall: uninstall-am
install-am: all-am
@$(MAKE) $(AM_MAKEFLAGS) install-exec-am install-data-am
installcheck: installcheck-am
install-strip:
if test -z '$(STRIP)'; then \
$(MAKE) $(AM_MAKEFLAGS) INSTALL_PROGRAM="$(INSTALL_STRIP_PROGRAM)" \
install_sh_PROGRAM="$(INSTALL_STRIP_PROGRAM)" INSTALL_STRIP_FLAG=-s \
install; \
else \
$(MAKE) $(AM_MAKEFLAGS) INSTALL_PROGRAM="$(INSTALL_STRIP_PROGRAM)" \
install_sh_PROGRAM="$(INSTALL_STRIP_PROGRAM)" INSTALL_STRIP_FLAG=-s \
"INSTALL_PROGRAM_ENV=STRIPPROG='$(STRIP)'" install; \
fi
mostlyclean-generic:
clean-generic:
distclean-generic:
-test -z "$(CONFIG_CLEAN_FILES)" || rm -f $(CONFIG_CLEAN_FILES)
-test . = "$(srcdir)" || test -z "$(CONFIG_CLEAN_VPATH_FILES)" || rm -f $(CONFIG_CLEAN_VPATH_FILES)
maintainer-clean-generic:
@echo "This command is intended for maintainers to use"
@echo "it deletes files that may require special tools to rebuild."
clean: clean-am
clean-am: clean-generic clean-libtool clean-noinstLTLIBRARIES \
mostlyclean-am
distclean: distclean-am
-rm -f ./$(DEPDIR)/AbsBinnedComparison1D.Plo
-rm -f ./$(DEPDIR)/AbsCGF1D.Plo
-rm -f ./$(DEPDIR)/AbsCVCopulaSmoother.Plo
-rm -f ./$(DEPDIR)/AbsCopulaSmootherBase.Plo
-rm -f ./$(DEPDIR)/AbsDiscreteDistribution1D.Plo
-rm -f ./$(DEPDIR)/AbsDistribution1D.Plo
-rm -f ./$(DEPDIR)/AbsDistributionND.Plo
-rm -f ./$(DEPDIR)/AbsDistributionTransform1D.Plo
-rm -f ./$(DEPDIR)/AbsFilter1DBuilder.Plo
-rm -f ./$(DEPDIR)/AbsKDE1DKernel.Plo
-rm -f ./$(DEPDIR)/AbsMarginalSmootherBase.Plo
-rm -f ./$(DEPDIR)/AbsNtuple.Plo
-rm -f ./$(DEPDIR)/AbsSmoothGOFTest1D.Plo
-rm -f ./$(DEPDIR)/AbsTwoDistros1DFunctor.Plo
-rm -f ./$(DEPDIR)/AbsUnbinnedGOFTest1D.Plo
-rm -f ./$(DEPDIR)/AbsUnfold1D.Plo
-rm -f ./$(DEPDIR)/AbsUnfoldND.Plo
-rm -f ./$(DEPDIR)/AbsUnfoldingFilterND.Plo
-rm -f ./$(DEPDIR)/AllSymbetaParams1D.Plo
-rm -f ./$(DEPDIR)/AsinhTransform1D.Plo
-rm -f ./$(DEPDIR)/BernsteinCopulaSmoother.Plo
-rm -f ./$(DEPDIR)/BernsteinFilter1DBuilder.Plo
-rm -f ./$(DEPDIR)/BetaFilter1DBuilder.Plo
-rm -f ./$(DEPDIR)/BinSummary.Plo
-rm -f ./$(DEPDIR)/BinnedADTest1D.Plo
-rm -f ./$(DEPDIR)/BinnedKSTest1D.Plo
-rm -f ./$(DEPDIR)/BoundaryHandling.Plo
-rm -f ./$(DEPDIR)/CdfTransform1D.Plo
-rm -f ./$(DEPDIR)/ChebyshevDistro1D.Plo
-rm -f ./$(DEPDIR)/ComparisonDistribution1D.Plo
-rm -f ./$(DEPDIR)/CompositeDistribution1D.Plo
-rm -f ./$(DEPDIR)/CompositeDistributionND.Plo
-rm -f ./$(DEPDIR)/ConstantBandwidthSmoother1D.Plo
-rm -f ./$(DEPDIR)/CopulaInterpolationND.Plo
-rm -f ./$(DEPDIR)/Copulas.Plo
-rm -f ./$(DEPDIR)/CrossCovarianceAccumulator.Plo
-rm -f ./$(DEPDIR)/DeltaMixture1D.Plo
-rm -f ./$(DEPDIR)/DensityOrthoPoly1D.Plo
-rm -f ./$(DEPDIR)/DensityScan1D.Plo
-rm -f ./$(DEPDIR)/DiscreteDistribution1DReader.Plo
-rm -f ./$(DEPDIR)/DiscreteDistributions1D.Plo
-rm -f ./$(DEPDIR)/DiscreteGauss1DBuilder.Plo
-rm -f ./$(DEPDIR)/DiscreteGaussCopulaSmoother.Plo
-rm -f ./$(DEPDIR)/Distribution1DFactory.Plo
-rm -f ./$(DEPDIR)/Distribution1DReader.Plo
-rm -f ./$(DEPDIR)/DistributionMix1D.Plo
-rm -f ./$(DEPDIR)/DistributionMixND.Plo
-rm -f ./$(DEPDIR)/DistributionNDReader.Plo
-rm -f ./$(DEPDIR)/DistributionTransform1DReader.Plo
-rm -f ./$(DEPDIR)/Distributions1D.Plo
-rm -f ./$(DEPDIR)/DistributionsND.Plo
-rm -f ./$(DEPDIR)/DualHistoAxis.Plo
-rm -f ./$(DEPDIR)/EdgeworthSeries1D.Plo
-rm -f ./$(DEPDIR)/EdgeworthSeriesMethod.Plo
-rm -f ./$(DEPDIR)/EllipticalDistribution.Plo
-rm -f ./$(DEPDIR)/EllipticalDistributions.Plo
-rm -f ./$(DEPDIR)/ExpTiltedDistribution1D.Plo
-rm -f ./$(DEPDIR)/Filter1DBuilders.Plo
-rm -f ./$(DEPDIR)/FoldedDistribution1D.Plo
-rm -f ./$(DEPDIR)/GaussianMixture1D.Plo
-rm -f ./$(DEPDIR)/GaussianMixtureEntry.Plo
-rm -f ./$(DEPDIR)/GridInterpolatedDistribution.Plo
-rm -f ./$(DEPDIR)/GridRandomizer.Plo
-rm -f ./$(DEPDIR)/HistoAxis.Plo
-rm -f ./$(DEPDIR)/HistoNDCdf.Plo
-rm -f ./$(DEPDIR)/IdentityTransform1D.Plo
-rm -f ./$(DEPDIR)/InterpolatedDistribution1D.Plo
-rm -f ./$(DEPDIR)/InterpolatedDistro1D1P.Plo
-rm -f ./$(DEPDIR)/InterpolatedDistro1DNP.Plo
-rm -f ./$(DEPDIR)/JohnsonCurves.Plo
-rm -f ./$(DEPDIR)/JohnsonKDESmoother.Plo
-rm -f ./$(DEPDIR)/JohnsonOrthoPoly1D.Plo
-rm -f ./$(DEPDIR)/KDE1DHOSymbetaKernel.Plo
-rm -f ./$(DEPDIR)/KernelSensitivityCalculator.Plo
-rm -f ./$(DEPDIR)/LOrPE1DSymbetaKernel.Plo
-rm -f ./$(DEPDIR)/LOrPEMarginalSmoother.Plo
-rm -f ./$(DEPDIR)/LeftCensoredDistribution.Plo
-rm -f ./$(DEPDIR)/LegendreDistro1D.Plo
-rm -f ./$(DEPDIR)/LikelihoodStatisticType.Plo
-rm -f ./$(DEPDIR)/LocScaleTransform1D.Plo
-rm -f ./$(DEPDIR)/LocalMultiFilter1D.Plo
-rm -f ./$(DEPDIR)/LocalPolyFilter1D.Plo
-rm -f ./$(DEPDIR)/LocalPolyFilter1DReader.Plo
-rm -f ./$(DEPDIR)/LocationScaleFamily1D.Plo
-rm -f ./$(DEPDIR)/LogRatioTransform1D.Plo
-rm -f ./$(DEPDIR)/LogTransform1D.Plo
-rm -f ./$(DEPDIR)/LognormalTransform1D.Plo
-rm -f ./$(DEPDIR)/MatrixFilter1DBuilder.Plo
-rm -f ./$(DEPDIR)/MemoizingSymbetaFilterProvider.Plo
-rm -f ./$(DEPDIR)/MultiscaleEMUnfold1D.Plo
-rm -f ./$(DEPDIR)/NMCombinationSequencer.Plo
-rm -f ./$(DEPDIR)/NUHistoAxis.Plo
-rm -f ./$(DEPDIR)/NeymanOSDE1D.Plo
+ -rm -f ./$(DEPDIR)/NeymanOSDE1DResult.Plo
-rm -f ./$(DEPDIR)/OSDE1D.Plo
-rm -f ./$(DEPDIR)/OrthoPolyGOFTest1D.Plo
-rm -f ./$(DEPDIR)/PearsonsChiSquared.Plo
-rm -f ./$(DEPDIR)/PolyFilterCollection1D.Plo
-rm -f ./$(DEPDIR)/PolynomialDistro1D.Plo
-rm -f ./$(DEPDIR)/PowerHalfCauchy1D.Plo
-rm -f ./$(DEPDIR)/PowerRatio1D.Plo
-rm -f ./$(DEPDIR)/PowerTransform1D.Plo
-rm -f ./$(DEPDIR)/ProductSymmetricBetaNDCdf.Plo
-rm -f ./$(DEPDIR)/QuadraticOrthoPolyND.Plo
-rm -f ./$(DEPDIR)/QuantileTable1D.Plo
-rm -f ./$(DEPDIR)/RatioOfNormals.Plo
-rm -f ./$(DEPDIR)/ResponseMatrix.Plo
-rm -f ./$(DEPDIR)/RightCensoredDistribution.Plo
-rm -f ./$(DEPDIR)/SbMomentsBigGamma.Plo
-rm -f ./$(DEPDIR)/SbMomentsCalculator.Plo
-rm -f ./$(DEPDIR)/ScalableGaussND.Plo
-rm -f ./$(DEPDIR)/SequentialCopulaSmoother.Plo
-rm -f ./$(DEPDIR)/SequentialGroupedCopulaSmoother.Plo
-rm -f ./$(DEPDIR)/SequentialPolyFilterND.Plo
-rm -f ./$(DEPDIR)/SeriesCGF1D.Plo
-rm -f ./$(DEPDIR)/SineGOFTest1D.Plo
-rm -f ./$(DEPDIR)/SinhAsinhTransform1D.Plo
-rm -f ./$(DEPDIR)/SmoothCDGOFTest1D.Plo
-rm -f ./$(DEPDIR)/SmoothedEMUnfold1D.Plo
-rm -f ./$(DEPDIR)/SmoothedEMUnfoldND.Plo
-rm -f ./$(DEPDIR)/StatAccumulator.Plo
-rm -f ./$(DEPDIR)/StatAccumulatorArr.Plo
-rm -f ./$(DEPDIR)/StatAccumulatorPair.Plo
-rm -f ./$(DEPDIR)/StatUtils.Plo
-rm -f ./$(DEPDIR)/StorableMultivariateFunctor.Plo
-rm -f ./$(DEPDIR)/StorableMultivariateFunctorReader.Plo
-rm -f ./$(DEPDIR)/SymbetaParams1D.Plo
-rm -f ./$(DEPDIR)/TransformedDistribution1D.Plo
-rm -f ./$(DEPDIR)/TruncatedDistribution1D.Plo
-rm -f ./$(DEPDIR)/TwoDistros1DFunctors.Plo
-rm -f ./$(DEPDIR)/UGaussConvolution1D.Plo
-rm -f ./$(DEPDIR)/UnbinnedGOFTest1DFactory.Plo
-rm -f ./$(DEPDIR)/UnbinnedGOFTests1D.Plo
-rm -f ./$(DEPDIR)/UnfoldingBandwidthScanner1D.Plo
-rm -f ./$(DEPDIR)/UnfoldingBandwidthScannerND.Plo
-rm -f ./$(DEPDIR)/UnfoldingFilterNDReader.Plo
-rm -f ./$(DEPDIR)/UnitMapInterpolationND.Plo
-rm -f ./$(DEPDIR)/VariableBandwidthSmoother1D.Plo
-rm -f ./$(DEPDIR)/VerticallyInterpolatedDistribution1D.Plo
-rm -f ./$(DEPDIR)/WeightTableFilter1DBuilder.Plo
-rm -f ./$(DEPDIR)/WeightedStatAccumulator.Plo
-rm -f ./$(DEPDIR)/WeightedStatAccumulatorPair.Plo
-rm -f ./$(DEPDIR)/amiseOptimalBandwidth.Plo
-rm -f ./$(DEPDIR)/bivariateChiSquare.Plo
-rm -f ./$(DEPDIR)/buildInterpolatedHelpers.Plo
-rm -f ./$(DEPDIR)/continuousDegreeTaper.Plo
-rm -f ./$(DEPDIR)/convertAxis.Plo
-rm -f ./$(DEPDIR)/correctDensityEstimateGHU.Plo
-rm -f ./$(DEPDIR)/distributionReadError.Plo
-rm -f ./$(DEPDIR)/distro1DStats.Plo
-rm -f ./$(DEPDIR)/fitSbParameters.Plo
-rm -f ./$(DEPDIR)/gaussianResponseMatrix.Plo
-rm -f ./$(DEPDIR)/johnsonIntegral.Plo
-rm -f ./$(DEPDIR)/johnsonTransform.Plo
-rm -f ./$(DEPDIR)/likelihoodStatisticCumulants.Plo
-rm -f ./$(DEPDIR)/logLikelihoodPeak.Plo
-rm -f ./$(DEPDIR)/lorpeMise1D.Plo
-rm -f ./$(DEPDIR)/make_UnbinnedGOFTest1D.Plo
-rm -f ./$(DEPDIR)/multinomialCovariance1D.Plo
-rm -f ./$(DEPDIR)/neymanPearsonWindow1D.Plo
-rm -f ./$(DEPDIR)/randomOrthogonalMatrix.Plo
-rm -f ./$(DEPDIR)/saddlepointDistribution1D.Plo
-rm -f ./$(DEPDIR)/scanMultivariateDensityAsWeight.Plo
-rm -f ./$(DEPDIR)/scanSymmetricDensityAsWeight.Plo
-rm -f ./$(DEPDIR)/scannedKSDistance.Plo
-rm -f ./$(DEPDIR)/solveForLOrPEWeights.Plo
-rm -f ./$(DEPDIR)/statUncertainties.Plo
-rm -f ./$(DEPDIR)/volumeDensityFromBinnedRadial.Plo
-rm -f Makefile
distclean-am: clean-am distclean-compile distclean-generic \
distclean-tags
dvi: dvi-am
dvi-am:
html: html-am
html-am:
info: info-am
info-am:
install-data-am: install-includeHEADERS
install-dvi: install-dvi-am
install-dvi-am:
install-exec-am:
install-html: install-html-am
install-html-am:
install-info: install-info-am
install-info-am:
install-man:
install-pdf: install-pdf-am
install-pdf-am:
install-ps: install-ps-am
install-ps-am:
installcheck-am:
maintainer-clean: maintainer-clean-am
-rm -f ./$(DEPDIR)/AbsBinnedComparison1D.Plo
-rm -f ./$(DEPDIR)/AbsCGF1D.Plo
-rm -f ./$(DEPDIR)/AbsCVCopulaSmoother.Plo
-rm -f ./$(DEPDIR)/AbsCopulaSmootherBase.Plo
-rm -f ./$(DEPDIR)/AbsDiscreteDistribution1D.Plo
-rm -f ./$(DEPDIR)/AbsDistribution1D.Plo
-rm -f ./$(DEPDIR)/AbsDistributionND.Plo
-rm -f ./$(DEPDIR)/AbsDistributionTransform1D.Plo
-rm -f ./$(DEPDIR)/AbsFilter1DBuilder.Plo
-rm -f ./$(DEPDIR)/AbsKDE1DKernel.Plo
-rm -f ./$(DEPDIR)/AbsMarginalSmootherBase.Plo
-rm -f ./$(DEPDIR)/AbsNtuple.Plo
-rm -f ./$(DEPDIR)/AbsSmoothGOFTest1D.Plo
-rm -f ./$(DEPDIR)/AbsTwoDistros1DFunctor.Plo
-rm -f ./$(DEPDIR)/AbsUnbinnedGOFTest1D.Plo
-rm -f ./$(DEPDIR)/AbsUnfold1D.Plo
-rm -f ./$(DEPDIR)/AbsUnfoldND.Plo
-rm -f ./$(DEPDIR)/AbsUnfoldingFilterND.Plo
-rm -f ./$(DEPDIR)/AllSymbetaParams1D.Plo
-rm -f ./$(DEPDIR)/AsinhTransform1D.Plo
-rm -f ./$(DEPDIR)/BernsteinCopulaSmoother.Plo
-rm -f ./$(DEPDIR)/BernsteinFilter1DBuilder.Plo
-rm -f ./$(DEPDIR)/BetaFilter1DBuilder.Plo
-rm -f ./$(DEPDIR)/BinSummary.Plo
-rm -f ./$(DEPDIR)/BinnedADTest1D.Plo
-rm -f ./$(DEPDIR)/BinnedKSTest1D.Plo
-rm -f ./$(DEPDIR)/BoundaryHandling.Plo
-rm -f ./$(DEPDIR)/CdfTransform1D.Plo
-rm -f ./$(DEPDIR)/ChebyshevDistro1D.Plo
-rm -f ./$(DEPDIR)/ComparisonDistribution1D.Plo
-rm -f ./$(DEPDIR)/CompositeDistribution1D.Plo
-rm -f ./$(DEPDIR)/CompositeDistributionND.Plo
-rm -f ./$(DEPDIR)/ConstantBandwidthSmoother1D.Plo
-rm -f ./$(DEPDIR)/CopulaInterpolationND.Plo
-rm -f ./$(DEPDIR)/Copulas.Plo
-rm -f ./$(DEPDIR)/CrossCovarianceAccumulator.Plo
-rm -f ./$(DEPDIR)/DeltaMixture1D.Plo
-rm -f ./$(DEPDIR)/DensityOrthoPoly1D.Plo
-rm -f ./$(DEPDIR)/DensityScan1D.Plo
-rm -f ./$(DEPDIR)/DiscreteDistribution1DReader.Plo
-rm -f ./$(DEPDIR)/DiscreteDistributions1D.Plo
-rm -f ./$(DEPDIR)/DiscreteGauss1DBuilder.Plo
-rm -f ./$(DEPDIR)/DiscreteGaussCopulaSmoother.Plo
-rm -f ./$(DEPDIR)/Distribution1DFactory.Plo
-rm -f ./$(DEPDIR)/Distribution1DReader.Plo
-rm -f ./$(DEPDIR)/DistributionMix1D.Plo
-rm -f ./$(DEPDIR)/DistributionMixND.Plo
-rm -f ./$(DEPDIR)/DistributionNDReader.Plo
-rm -f ./$(DEPDIR)/DistributionTransform1DReader.Plo
-rm -f ./$(DEPDIR)/Distributions1D.Plo
-rm -f ./$(DEPDIR)/DistributionsND.Plo
-rm -f ./$(DEPDIR)/DualHistoAxis.Plo
-rm -f ./$(DEPDIR)/EdgeworthSeries1D.Plo
-rm -f ./$(DEPDIR)/EdgeworthSeriesMethod.Plo
-rm -f ./$(DEPDIR)/EllipticalDistribution.Plo
-rm -f ./$(DEPDIR)/EllipticalDistributions.Plo
-rm -f ./$(DEPDIR)/ExpTiltedDistribution1D.Plo
-rm -f ./$(DEPDIR)/Filter1DBuilders.Plo
-rm -f ./$(DEPDIR)/FoldedDistribution1D.Plo
-rm -f ./$(DEPDIR)/GaussianMixture1D.Plo
-rm -f ./$(DEPDIR)/GaussianMixtureEntry.Plo
-rm -f ./$(DEPDIR)/GridInterpolatedDistribution.Plo
-rm -f ./$(DEPDIR)/GridRandomizer.Plo
-rm -f ./$(DEPDIR)/HistoAxis.Plo
-rm -f ./$(DEPDIR)/HistoNDCdf.Plo
-rm -f ./$(DEPDIR)/IdentityTransform1D.Plo
-rm -f ./$(DEPDIR)/InterpolatedDistribution1D.Plo
-rm -f ./$(DEPDIR)/InterpolatedDistro1D1P.Plo
-rm -f ./$(DEPDIR)/InterpolatedDistro1DNP.Plo
-rm -f ./$(DEPDIR)/JohnsonCurves.Plo
-rm -f ./$(DEPDIR)/JohnsonKDESmoother.Plo
-rm -f ./$(DEPDIR)/JohnsonOrthoPoly1D.Plo
-rm -f ./$(DEPDIR)/KDE1DHOSymbetaKernel.Plo
-rm -f ./$(DEPDIR)/KernelSensitivityCalculator.Plo
-rm -f ./$(DEPDIR)/LOrPE1DSymbetaKernel.Plo
-rm -f ./$(DEPDIR)/LOrPEMarginalSmoother.Plo
-rm -f ./$(DEPDIR)/LeftCensoredDistribution.Plo
-rm -f ./$(DEPDIR)/LegendreDistro1D.Plo
-rm -f ./$(DEPDIR)/LikelihoodStatisticType.Plo
-rm -f ./$(DEPDIR)/LocScaleTransform1D.Plo
-rm -f ./$(DEPDIR)/LocalMultiFilter1D.Plo
-rm -f ./$(DEPDIR)/LocalPolyFilter1D.Plo
-rm -f ./$(DEPDIR)/LocalPolyFilter1DReader.Plo
-rm -f ./$(DEPDIR)/LocationScaleFamily1D.Plo
-rm -f ./$(DEPDIR)/LogRatioTransform1D.Plo
-rm -f ./$(DEPDIR)/LogTransform1D.Plo
-rm -f ./$(DEPDIR)/LognormalTransform1D.Plo
-rm -f ./$(DEPDIR)/MatrixFilter1DBuilder.Plo
-rm -f ./$(DEPDIR)/MemoizingSymbetaFilterProvider.Plo
-rm -f ./$(DEPDIR)/MultiscaleEMUnfold1D.Plo
-rm -f ./$(DEPDIR)/NMCombinationSequencer.Plo
-rm -f ./$(DEPDIR)/NUHistoAxis.Plo
-rm -f ./$(DEPDIR)/NeymanOSDE1D.Plo
+ -rm -f ./$(DEPDIR)/NeymanOSDE1DResult.Plo
-rm -f ./$(DEPDIR)/OSDE1D.Plo
-rm -f ./$(DEPDIR)/OrthoPolyGOFTest1D.Plo
-rm -f ./$(DEPDIR)/PearsonsChiSquared.Plo
-rm -f ./$(DEPDIR)/PolyFilterCollection1D.Plo
-rm -f ./$(DEPDIR)/PolynomialDistro1D.Plo
-rm -f ./$(DEPDIR)/PowerHalfCauchy1D.Plo
-rm -f ./$(DEPDIR)/PowerRatio1D.Plo
-rm -f ./$(DEPDIR)/PowerTransform1D.Plo
-rm -f ./$(DEPDIR)/ProductSymmetricBetaNDCdf.Plo
-rm -f ./$(DEPDIR)/QuadraticOrthoPolyND.Plo
-rm -f ./$(DEPDIR)/QuantileTable1D.Plo
-rm -f ./$(DEPDIR)/RatioOfNormals.Plo
-rm -f ./$(DEPDIR)/ResponseMatrix.Plo
-rm -f ./$(DEPDIR)/RightCensoredDistribution.Plo
-rm -f ./$(DEPDIR)/SbMomentsBigGamma.Plo
-rm -f ./$(DEPDIR)/SbMomentsCalculator.Plo
-rm -f ./$(DEPDIR)/ScalableGaussND.Plo
-rm -f ./$(DEPDIR)/SequentialCopulaSmoother.Plo
-rm -f ./$(DEPDIR)/SequentialGroupedCopulaSmoother.Plo
-rm -f ./$(DEPDIR)/SequentialPolyFilterND.Plo
-rm -f ./$(DEPDIR)/SeriesCGF1D.Plo
-rm -f ./$(DEPDIR)/SineGOFTest1D.Plo
-rm -f ./$(DEPDIR)/SinhAsinhTransform1D.Plo
-rm -f ./$(DEPDIR)/SmoothCDGOFTest1D.Plo
-rm -f ./$(DEPDIR)/SmoothedEMUnfold1D.Plo
-rm -f ./$(DEPDIR)/SmoothedEMUnfoldND.Plo
-rm -f ./$(DEPDIR)/StatAccumulator.Plo
-rm -f ./$(DEPDIR)/StatAccumulatorArr.Plo
-rm -f ./$(DEPDIR)/StatAccumulatorPair.Plo
-rm -f ./$(DEPDIR)/StatUtils.Plo
-rm -f ./$(DEPDIR)/StorableMultivariateFunctor.Plo
-rm -f ./$(DEPDIR)/StorableMultivariateFunctorReader.Plo
-rm -f ./$(DEPDIR)/SymbetaParams1D.Plo
-rm -f ./$(DEPDIR)/TransformedDistribution1D.Plo
-rm -f ./$(DEPDIR)/TruncatedDistribution1D.Plo
-rm -f ./$(DEPDIR)/TwoDistros1DFunctors.Plo
-rm -f ./$(DEPDIR)/UGaussConvolution1D.Plo
-rm -f ./$(DEPDIR)/UnbinnedGOFTest1DFactory.Plo
-rm -f ./$(DEPDIR)/UnbinnedGOFTests1D.Plo
-rm -f ./$(DEPDIR)/UnfoldingBandwidthScanner1D.Plo
-rm -f ./$(DEPDIR)/UnfoldingBandwidthScannerND.Plo
-rm -f ./$(DEPDIR)/UnfoldingFilterNDReader.Plo
-rm -f ./$(DEPDIR)/UnitMapInterpolationND.Plo
-rm -f ./$(DEPDIR)/VariableBandwidthSmoother1D.Plo
-rm -f ./$(DEPDIR)/VerticallyInterpolatedDistribution1D.Plo
-rm -f ./$(DEPDIR)/WeightTableFilter1DBuilder.Plo
-rm -f ./$(DEPDIR)/WeightedStatAccumulator.Plo
-rm -f ./$(DEPDIR)/WeightedStatAccumulatorPair.Plo
-rm -f ./$(DEPDIR)/amiseOptimalBandwidth.Plo
-rm -f ./$(DEPDIR)/bivariateChiSquare.Plo
-rm -f ./$(DEPDIR)/buildInterpolatedHelpers.Plo
-rm -f ./$(DEPDIR)/continuousDegreeTaper.Plo
-rm -f ./$(DEPDIR)/convertAxis.Plo
-rm -f ./$(DEPDIR)/correctDensityEstimateGHU.Plo
-rm -f ./$(DEPDIR)/distributionReadError.Plo
-rm -f ./$(DEPDIR)/distro1DStats.Plo
-rm -f ./$(DEPDIR)/fitSbParameters.Plo
-rm -f ./$(DEPDIR)/gaussianResponseMatrix.Plo
-rm -f ./$(DEPDIR)/johnsonIntegral.Plo
-rm -f ./$(DEPDIR)/johnsonTransform.Plo
-rm -f ./$(DEPDIR)/likelihoodStatisticCumulants.Plo
-rm -f ./$(DEPDIR)/logLikelihoodPeak.Plo
-rm -f ./$(DEPDIR)/lorpeMise1D.Plo
-rm -f ./$(DEPDIR)/make_UnbinnedGOFTest1D.Plo
-rm -f ./$(DEPDIR)/multinomialCovariance1D.Plo
-rm -f ./$(DEPDIR)/neymanPearsonWindow1D.Plo
-rm -f ./$(DEPDIR)/randomOrthogonalMatrix.Plo
-rm -f ./$(DEPDIR)/saddlepointDistribution1D.Plo
-rm -f ./$(DEPDIR)/scanMultivariateDensityAsWeight.Plo
-rm -f ./$(DEPDIR)/scanSymmetricDensityAsWeight.Plo
-rm -f ./$(DEPDIR)/scannedKSDistance.Plo
-rm -f ./$(DEPDIR)/solveForLOrPEWeights.Plo
-rm -f ./$(DEPDIR)/statUncertainties.Plo
-rm -f ./$(DEPDIR)/volumeDensityFromBinnedRadial.Plo
-rm -f Makefile
maintainer-clean-am: distclean-am maintainer-clean-generic
mostlyclean: mostlyclean-am
mostlyclean-am: mostlyclean-compile mostlyclean-generic \
mostlyclean-libtool
pdf: pdf-am
pdf-am:
ps: ps-am
ps-am:
python: python-am
python-am: python-local
uninstall-am: uninstall-includeHEADERS
.MAKE: install-am install-strip
.PHONY: CTAGS GTAGS TAGS all all-am am--depfiles check check-am clean \
clean-generic clean-libtool clean-noinstLTLIBRARIES \
cscopelist-am ctags ctags-am distclean distclean-compile \
distclean-generic distclean-libtool distclean-tags distdir dvi \
dvi-am html html-am info info-am install install-am \
install-data install-data-am install-dvi install-dvi-am \
install-exec install-exec-am install-html install-html-am \
install-includeHEADERS install-info install-info-am \
install-man install-pdf install-pdf-am install-ps \
install-ps-am install-strip installcheck installcheck-am \
installdirs maintainer-clean maintainer-clean-generic \
mostlyclean mostlyclean-compile mostlyclean-generic \
mostlyclean-libtool pdf pdf-am ps ps-am python-am python-local \
tags tags-am uninstall uninstall-am uninstall-includeHEADERS
.PRECIOUS: Makefile
# Tell versions [3.59,3.63) of GNU make to not export all variables.
# Otherwise a system limit (for SysV at least) may be exceeded.
.NOEXPORT:
Index: trunk/npstat/stat/gradientDescentForNeymanOSDE1D.hh
===================================================================
--- trunk/npstat/stat/gradientDescentForNeymanOSDE1D.hh (revision 896)
+++ trunk/npstat/stat/gradientDescentForNeymanOSDE1D.hh (revision 897)
@@ -1,112 +1,110 @@
#ifndef NPSTAT_GRADIENTDESCENTFORNEYMANOSDE1D_HH_
#define NPSTAT_GRADIENTDESCENTFORNEYMANOSDE1D_HH_
#include <cmath>
#include <cassert>
#include <utility>
#include <algorithm>
#include "npstat/nm/maxAbsValue.hh"
#include "npstat/nm/scalesFromHessian.hh"
#include "npstat/nm/SimpleScalarProduct.hh"
#include "npstat/stat/NeymanOSDE1D.hh"
#include "npstat/stat/NeymanOSDE1DResult.hh"
namespace npstat {
// The class "ConvergenceCalculator" must have a method
// "bool converged(...) const" with the same signature as the
// "converged" method of class "GradientNeymanOSDE1DConvergenceCalc".
template<class ConvergenceCalculator>
inline NeymanOSDE1DResult gradientDescentForNeymanOSDE1D(
const NeymanOSDE1D& nosde,
const double* initialCoeffs, const unsigned nCoeffs,
const double* shrinkages, const unsigned nShrinkages,
const ConvergenceCalculator& conv, const unsigned maxIterations)
{
- const unsigned minimizerCode = 2U;
-
// Some hardwired parameters
const double armijoC = 0.5;
const double armijoTau = 0.5;
const unsigned maxLineIterations = 100;
std::vector<double> coeffs(initialCoeffs, initialCoeffs+nCoeffs);
std::vector<double> lineSearchCoeffs(nCoeffs);
std::vector<double> polyStats(nShrinkages);
std::vector<double> prevGradient(nCoeffs);
std::vector<double> currentGradient(nCoeffs);
std::vector<double> hessianEigenvalues(nCoeffs);
std::vector<double> step(nCoeffs);
std::vector<double> unitStep(nCoeffs);
std::vector<double> scales(nCoeffs);
Matrix<double> hessian(nCoeffs, nCoeffs);
SimpleScalarProduct<double> sp;
double prevChisq = nosde.chiSquare(&coeffs[0], nCoeffs,
shrinkages, nShrinkages,
&polyStats[0], &prevGradient[0],
&hessian);
bool converged = false;
unsigned iter = 0;
for (; iter<maxIterations && !converged; ++iter)
{
// Try to get some idea about possible step sizes
scalesFromHessian(hessian, 1.0, &scales[0], nCoeffs);
// Figure out the "unit step" in the direction
// opposing the gradient
const double gradientNorm = std::sqrt(sp(&prevGradient[0], &prevGradient[0], nCoeffs));
assert(gradientNorm > 0.0);
for (unsigned i=0; i<nCoeffs; ++i)
unitStep[i] = -prevGradient[i]*scales[i]/gradientNorm;
const double unitStepLen = std::sqrt(sp(&unitStep[0], &unitStep[0], nCoeffs));
assert(unitStepLen > 0.0);
for (unsigned i=0; i<nCoeffs; ++i)
unitStep[i] = -prevGradient[i]/gradientNorm;
// Now perform backtracking line search
// const double m = sp(&unitStep[0], &prevGradient[0], nCoeffs);
// assert(m < 0.0);
const double m = -gradientNorm;
double alpha = unitStepLen/armijoTau;
bool lineIterConverged = false;
unsigned lit = 0;
double lineChisq = 0.0;
for (; lit<maxLineIterations && !lineIterConverged; ++lit)
{
alpha *= armijoTau;
for (unsigned i=0; i<nCoeffs; ++i)
{
step[i] = unitStep[i]*alpha;
lineSearchCoeffs[i] = coeffs[i] + step[i];
}
lineChisq = nosde.chiSquare(
&lineSearchCoeffs[0], nCoeffs, shrinkages, nShrinkages,
&polyStats[0], &currentGradient[0], nullptr);
lineIterConverged = lineChisq <= prevChisq + alpha*armijoC*m;
}
assert(lineIterConverged);
// std::cout << "Made " << lit << " line iterations" << std::endl;
// Recalculate the Hessian
for (unsigned i=0; i<nCoeffs; ++i)
coeffs[i] = lineSearchCoeffs[i];
const double currentChisq = nosde.chiSquare(&coeffs[0], nCoeffs,
shrinkages, nShrinkages,
&polyStats[0], &currentGradient[0],
&hessian);
converged = conv.converged(iter, prevChisq, prevGradient, step,
currentChisq, currentGradient, hessian);
prevChisq = currentChisq;
std::swap(prevGradient, currentGradient);
}
return NeymanOSDE1DResult(coeffs, polyStats, prevChisq,
maxAbsValue(&prevGradient[0], prevGradient.size()),
- minimizerCode, iter, converged, false);
+ NOSDE_GRADIENT_DESCENT, iter, converged, false);
}
}
#endif // NPSTAT_GRADIENTDESCENTFORNEYMANOSDE1D_HH_
Index: trunk/config.log
===================================================================
--- trunk/config.log (revision 896)
+++ trunk/config.log (revision 897)
@@ -1,1181 +1,1180 @@
This file contains any messages produced by compilers while
running configure, to aid debugging if configure makes a mistake.
It was created by npstat configure 5.10.0, which was
generated by GNU Autoconf 2.71. Invocation command line was
$ ./configure --disable-static --with-pic
## --------- ##
## Platform. ##
## --------- ##
hostname = dawn
uname -m = x86_64
uname -r = 5.15.0-67-generic
uname -s = Linux
uname -v = #74-Ubuntu SMP Wed Feb 22 14:14:39 UTC 2023
/usr/bin/uname -p = x86_64
/bin/uname -X = unknown
/bin/arch = x86_64
/usr/bin/arch -k = unknown
/usr/convex/getsysinfo = unknown
/usr/bin/hostinfo = unknown
/bin/machine = unknown
/usr/bin/oslevel = unknown
/bin/universe = unknown
PATH: /home/igv/bin/
PATH: /home/igv/local/bin/
PATH: /usr/local/anaconda3/bin/
PATH: /usr/local/bin/
PATH: /usr/local/root/bin/
PATH: /usr/local/bin/
PATH: /bin/
PATH: /usr/bin/
PATH: /sbin/
PATH: /usr/sbin/
PATH: ./
## ----------- ##
## Core tests. ##
## ----------- ##
configure:2816: looking for aux files: compile ltmain.sh config.guess config.sub missing install-sh
configure:2829: trying ./
configure:2858: ./compile found
configure:2858: ./ltmain.sh found
configure:2858: ./config.guess found
configure:2858: ./config.sub found
configure:2858: ./missing found
configure:2840: ./install-sh found
configure:2988: checking for a BSD-compatible install
configure:3061: result: /bin/install -c
configure:3072: checking whether build environment is sane
configure:3127: result: yes
configure:3286: checking for a race-free mkdir -p
configure:3330: result: /bin/mkdir -p
configure:3337: checking for gawk
configure:3372: result: no
configure:3337: checking for mawk
configure:3358: found /bin/mawk
configure:3369: result: mawk
configure:3380: checking whether make sets $(MAKE)
configure:3403: result: yes
configure:3433: checking whether make supports nested variables
configure:3451: result: yes
configure:3650: checking for pkg-config
configure:3673: found /bin/pkg-config
configure:3685: result: /bin/pkg-config
configure:3710: checking pkg-config is at least version 0.9.0
configure:3713: result: yes
configure:3723: checking for fftw3 >= 3.1.2 geners >= 1.3.0 kstest >= 2.0.0
configure:3730: $PKG_CONFIG --exists --print-errors "fftw3 >= 3.1.2 geners >= 1.3.0 kstest >= 2.0.0"
configure:3733: $? = 0
configure:3747: $PKG_CONFIG --exists --print-errors "fftw3 >= 3.1.2 geners >= 1.3.0 kstest >= 2.0.0"
configure:3750: $? = 0
configure:3808: result: yes
configure:3882: checking for g++
configure:3903: found /bin/g++
configure:3914: result: g++
configure:3941: checking for C++ compiler version
configure:3950: g++ --version >&5
g++ (Ubuntu 11.3.0-1ubuntu1~22.04) 11.3.0
Copyright (C) 2021 Free Software Foundation, Inc.
This is free software; see the source for copying conditions. There is NO
warranty; not even for MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE.
configure:3961: $? = 0
configure:3950: g++ -v >&5
Using built-in specs.
COLLECT_GCC=g++
COLLECT_LTO_WRAPPER=/usr/lib/gcc/x86_64-linux-gnu/11/lto-wrapper
OFFLOAD_TARGET_NAMES=nvptx-none:amdgcn-amdhsa
OFFLOAD_TARGET_DEFAULT=1
Target: x86_64-linux-gnu
Configured with: ../src/configure -v --with-pkgversion='Ubuntu 11.3.0-1ubuntu1~22.04' --with-bugurl=file:///usr/share/doc/gcc-11/README.Bugs --enable-languages=c,ada,c++,go,brig,d,fortran,objc,obj-c++,m2 --prefix=/usr --with-gcc-major-version-only --program-suffix=-11 --program-prefix=x86_64-linux-gnu- --enable-shared --enable-linker-build-id --libexecdir=/usr/lib --without-included-gettext --enable-threads=posix --libdir=/usr/lib --enable-nls --enable-bootstrap --enable-clocale=gnu --enable-libstdcxx-debug --enable-libstdcxx-time=yes --with-default-libstdcxx-abi=new --enable-gnu-unique-object --disable-vtable-verify --enable-plugin --enable-default-pie --with-system-zlib --enable-libphobos-checking=release --with-target-system-zlib=auto --enable-objc-gc=auto --enable-multiarch --disable-werror --enable-cet --with-arch-32=i686 --with-abi=m64 --with-multilib-list=m32,m64,mx32 --enable-multilib --with-tune=generic --enable-offload-targets=nvptx-none=/build/gcc-11-xKiWfi/gcc-11-11.3.0/debian/tmp-nvptx/usr,amdgcn-amdhsa=/build/gcc-11-xKiWfi/gcc-11-11.3.0/debian/tmp-gcn/usr --without-cuda-driver --enable-checking=release --build=x86_64-linux-gnu --host=x86_64-linux-gnu --target=x86_64-linux-gnu --with-build-config=bootstrap-lto-lean --enable-link-serialization=2
Thread model: posix
Supported LTO compression algorithms: zlib zstd
gcc version 11.3.0 (Ubuntu 11.3.0-1ubuntu1~22.04)
... rest of stderr output deleted ...
configure:3961: $? = 0
configure:3950: g++ -V >&5
g++: error: unrecognized command-line option '-V'
g++: fatal error: no input files
compilation terminated.
configure:3961: $? = 1
configure:3950: g++ -qversion >&5
g++: error: unrecognized command-line option '-qversion'; did you mean '--version'?
g++: fatal error: no input files
compilation terminated.
configure:3961: $? = 1
configure:3981: checking whether the C++ compiler works
configure:4003: g++ -std=c++11 -O3 -Wall -W -Werror conftest.cpp >&5
configure:4007: $? = 0
configure:4057: result: yes
configure:4060: checking for C++ compiler default output file name
configure:4062: result: a.out
configure:4068: checking for suffix of executables
configure:4075: g++ -o conftest -std=c++11 -O3 -Wall -W -Werror conftest.cpp >&5
configure:4079: $? = 0
configure:4102: result:
configure:4124: checking whether we are cross compiling
configure:4132: g++ -o conftest -std=c++11 -O3 -Wall -W -Werror conftest.cpp >&5
configure:4136: $? = 0
configure:4143: ./conftest
configure:4147: $? = 0
configure:4162: result: no
configure:4167: checking for suffix of object files
configure:4190: g++ -c -std=c++11 -O3 -Wall -W -Werror conftest.cpp >&5
configure:4194: $? = 0
configure:4216: result: o
configure:4220: checking whether the compiler supports GNU C++
configure:4240: g++ -c -std=c++11 -O3 -Wall -W -Werror conftest.cpp >&5
configure:4240: $? = 0
configure:4250: result: yes
configure:4261: checking whether g++ accepts -g
configure:4282: g++ -c -g conftest.cpp >&5
configure:4282: $? = 0
configure:4326: result: yes
configure:4346: checking for g++ option to enable C++11 features
configure:4361: g++ -c -std=c++11 -O3 -Wall -W -Werror conftest.cpp >&5
conftest.cpp: In function 'int main(int, char**)':
conftest.cpp:134:8: error: unused variable 'a1' [-Werror=unused-variable]
134 | auto a1 = 6538;
| ^~
conftest.cpp:141:16: error: unused variable 'a4' [-Werror=unused-variable]
141 | decltype(a2) a4 = 34895.034;
| ^~
conftest.cpp:145:9: error: unused variable 'sa' [-Werror=unused-variable]
145 | short sa[cxx11test::get_val()] = { 0 };
| ^~
conftest.cpp:149:23: error: unused variable 'il' [-Werror=unused-variable]
149 | cxx11test::testinit il = { 4323, 435234.23544 };
| ^~
conftest.cpp:170:8: error: unused variable 'a' [-Werror=unused-variable]
170 | auto a = sum(1);
| ^
conftest.cpp:171:8: error: unused variable 'b' [-Werror=unused-variable]
171 | auto b = sum(1, 2);
| ^
conftest.cpp:172:8: error: unused variable 'c' [-Werror=unused-variable]
172 | auto c = sum(1.0, 2.0, 3.0);
| ^
conftest.cpp:177:25: error: empty parentheses were disambiguated as a function declaration [-Werror=vexing-parse]
177 | cxx11test::delegate d2();
| ^~
conftest.cpp:177:25: note: remove parentheses to default-initialize a variable
177 | cxx11test::delegate d2();
| ^~
| --
conftest.cpp:177:25: note: or replace parentheses with braces to value-initialize a variable
conftest.cpp:186:9: error: unused variable 'c' [-Werror=unused-variable]
186 | char *c = nullptr;
| ^
conftest.cpp:194:15: error: unused variable 'utf8' [-Werror=unused-variable]
194 | char const *utf8 = u8"UTF-8 string \u2500";
| ^~~~
conftest.cpp:195:19: error: unused variable 'utf16' [-Werror=unused-variable]
195 | char16_t const *utf16 = u"UTF-8 string \u2500";
| ^~~~~
conftest.cpp:196:19: error: unused variable 'utf32' [-Werror=unused-variable]
196 | char32_t const *utf32 = U"UTF-32 string \u2500";
| ^~~~~
cc1plus: all warnings being treated as errors
configure:4361: $? = 1
configure: failed program was:
| /* confdefs.h */
| #define PACKAGE_NAME "npstat"
| #define PACKAGE_TARNAME "npstat"
| #define PACKAGE_VERSION "5.10.0"
| #define PACKAGE_STRING "npstat 5.10.0"
| #define PACKAGE_BUGREPORT ""
| #define PACKAGE_URL ""
| #define PACKAGE "npstat"
| #define VERSION "5.10.0"
| /* end confdefs.h. */
|
| // Does the compiler advertise C++98 conformance?
| #if !defined __cplusplus || __cplusplus < 199711L
| # error "Compiler does not advertise C++98 conformance"
| #endif
|
| // These inclusions are to reject old compilers that
| // lack the unsuffixed header files.
| #include <cstdlib>
| #include <exception>
|
| // <cassert> and <cstring> are *not* freestanding headers in C++98.
| extern void assert (int);
| namespace std {
| extern int strcmp (const char *, const char *);
| }
|
| // Namespaces, exceptions, and templates were all added after "C++ 2.0".
| using std::exception;
| using std::strcmp;
|
| namespace {
|
| void test_exception_syntax()
| {
| try {
| throw "test";
| } catch (const char *s) {
| // Extra parentheses suppress a warning when building autoconf itself,
| // due to lint rules shared with more typical C programs.
| assert (!(strcmp) (s, "test"));
| }
| }
|
| template <typename T> struct test_template
| {
| T const val;
| explicit test_template(T t) : val(t) {}
| template <typename U> T add(U u) { return static_cast<T>(u) + val; }
| };
|
| } // anonymous namespace
|
|
| // Does the compiler advertise C++ 2011 conformance?
| #if !defined __cplusplus || __cplusplus < 201103L
| # error "Compiler does not advertise C++11 conformance"
| #endif
|
| namespace cxx11test
| {
| constexpr int get_val() { return 20; }
|
| struct testinit
| {
| int i;
| double d;
| };
|
| class delegate
| {
| public:
| delegate(int n) : n(n) {}
| delegate(): delegate(2354) {}
|
| virtual int getval() { return this->n; };
| protected:
| int n;
| };
|
| class overridden : public delegate
| {
| public:
| overridden(int n): delegate(n) {}
| virtual int getval() override final { return this->n * 2; }
| };
|
| class nocopy
| {
| public:
| nocopy(int i): i(i) {}
| nocopy() = default;
| nocopy(const nocopy&) = delete;
| nocopy & operator=(const nocopy&) = delete;
| private:
| int i;
| };
|
| // for testing lambda expressions
| template <typename Ret, typename Fn> Ret eval(Fn f, Ret v)
| {
| return f(v);
| }
|
| // for testing variadic templates and trailing return types
| template <typename V> auto sum(V first) -> V
| {
| return first;
| }
| template <typename V, typename... Args> auto sum(V first, Args... rest) -> V
| {
| return first + sum(rest...);
| }
| }
|
|
| int
| main (int argc, char **argv)
| {
| int ok = 0;
|
| assert (argc);
| assert (! argv[0]);
| {
| test_exception_syntax ();
| test_template<double> tt (2.0);
| assert (tt.add (4) == 6.0);
| assert (true && !false);
| }
|
|
| {
| // Test auto and decltype
| auto a1 = 6538;
| auto a2 = 48573953.4;
| auto a3 = "String literal";
|
| int total = 0;
| for (auto i = a3; *i; ++i) { total += *i; }
|
| decltype(a2) a4 = 34895.034;
| }
| {
| // Test constexpr
| short sa[cxx11test::get_val()] = { 0 };
| }
| {
| // Test initializer lists
| cxx11test::testinit il = { 4323, 435234.23544 };
| }
| {
| // Test range-based for
| int array[] = {9, 7, 13, 15, 4, 18, 12, 10, 5, 3,
| 14, 19, 17, 8, 6, 20, 16, 2, 11, 1};
| for (auto &x : array) { x += 23; }
| }
| {
| // Test lambda expressions
| using cxx11test::eval;
| assert (eval ([](int x) { return x*2; }, 21) == 42);
| double d = 2.0;
| assert (eval ([&](double x) { return d += x; }, 3.0) == 5.0);
| assert (d == 5.0);
| assert (eval ([=](double x) mutable { return d += x; }, 4.0) == 9.0);
| assert (d == 5.0);
| }
| {
| // Test use of variadic templates
| using cxx11test::sum;
| auto a = sum(1);
| auto b = sum(1, 2);
| auto c = sum(1.0, 2.0, 3.0);
| }
| {
| // Test constructor delegation
| cxx11test::delegate d1;
| cxx11test::delegate d2();
| cxx11test::delegate d3(45);
| }
| {
| // Test override and final
| cxx11test::overridden o1(55464);
| }
| {
| // Test nullptr
| char *c = nullptr;
| }
| {
| // Test template brackets
| test_template<::test_template<int>> v(test_template<int>(12));
| }
| {
| // Unicode literals
| char const *utf8 = u8"UTF-8 string \u2500";
| char16_t const *utf16 = u"UTF-8 string \u2500";
| char32_t const *utf32 = U"UTF-32 string \u2500";
| }
|
| return ok;
| }
|
configure:4379: result: none needed
configure:4446: checking whether make supports the include directive
configure:4461: make -f confmf.GNU && cat confinc.out
this is the am__doit target
configure:4464: $? = 0
configure:4483: result: yes (GNU style)
configure:4509: checking dependency style of g++
configure:4621: result: gcc3
configure:4695: checking for g77
configure:4716: found /home/igv/bin/g77
configure:4727: result: g77
configure:4753: checking for Fortran 77 compiler version
configure:4762: g77 --version >&5
GNU Fortran (Ubuntu 11.3.0-1ubuntu1~22.04) 11.3.0
Copyright (C) 2021 Free Software Foundation, Inc.
This is free software; see the source for copying conditions. There is NO
warranty; not even for MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE.
configure:4773: $? = 0
configure:4762: g77 -v >&5
Using built-in specs.
COLLECT_GCC=g77
COLLECT_LTO_WRAPPER=/usr/lib/gcc/x86_64-linux-gnu/11/lto-wrapper
OFFLOAD_TARGET_NAMES=nvptx-none:amdgcn-amdhsa
OFFLOAD_TARGET_DEFAULT=1
Target: x86_64-linux-gnu
Configured with: ../src/configure -v --with-pkgversion='Ubuntu 11.3.0-1ubuntu1~22.04' --with-bugurl=file:///usr/share/doc/gcc-11/README.Bugs --enable-languages=c,ada,c++,go,brig,d,fortran,objc,obj-c++,m2 --prefix=/usr --with-gcc-major-version-only --program-suffix=-11 --program-prefix=x86_64-linux-gnu- --enable-shared --enable-linker-build-id --libexecdir=/usr/lib --without-included-gettext --enable-threads=posix --libdir=/usr/lib --enable-nls --enable-bootstrap --enable-clocale=gnu --enable-libstdcxx-debug --enable-libstdcxx-time=yes --with-default-libstdcxx-abi=new --enable-gnu-unique-object --disable-vtable-verify --enable-plugin --enable-default-pie --with-system-zlib --enable-libphobos-checking=release --with-target-system-zlib=auto --enable-objc-gc=auto --enable-multiarch --disable-werror --enable-cet --with-arch-32=i686 --with-abi=m64 --with-multilib-list=m32,m64,mx32 --enable-multilib --with-tune=generic --enable-offload-targets=nvptx-none=/build/gcc-11-xKiWfi/gcc-11-11.3.0/debian/tmp-nvptx/usr,amdgcn-amdhsa=/build/gcc-11-xKiWfi/gcc-11-11.3.0/debian/tmp-gcn/usr --without-cuda-driver --enable-checking=release --build=x86_64-linux-gnu --host=x86_64-linux-gnu --target=x86_64-linux-gnu --with-build-config=bootstrap-lto-lean --enable-link-serialization=2
Thread model: posix
Supported LTO compression algorithms: zlib zstd
gcc version 11.3.0 (Ubuntu 11.3.0-1ubuntu1~22.04)
... rest of stderr output deleted ...
configure:4773: $? = 0
configure:4762: g77 -V >&5
g77: error: unrecognized command-line option '-V'
g77: fatal error: no input files
compilation terminated.
configure:4773: $? = 1
configure:4762: g77 -qversion >&5
g77: error: unrecognized command-line option '-qversion'; did you mean '--version'?
g77: fatal error: no input files
compilation terminated.
configure:4773: $? = 1
configure:4782: checking whether the compiler supports GNU Fortran 77
configure:4796: g77 -c conftest.F >&5
configure:4796: $? = 0
configure:4806: result: yes
configure:4814: checking whether g77 accepts -g
configure:4826: g77 -c -g conftest.f >&5
configure:4826: $? = 0
configure:4835: result: yes
configure:4870: checking build system type
configure:4885: result: x86_64-pc-linux-gnu
configure:4905: checking host system type
configure:4919: result: x86_64-pc-linux-gnu
configure:4944: checking how to get verbose linking output from g77
configure:4955: g77 -c -g -O2 conftest.f >&5
configure:4955: $? = 0
configure:4974: g77 -o conftest -g -O2 -v conftest.f
Using built-in specs.
Target: x86_64-linux-gnu
Thread model: posix
Supported LTO compression algorithms: zlib zstd
gcc version 11.3.0 (Ubuntu 11.3.0-1ubuntu1~22.04)
- /usr/lib/gcc/x86_64-linux-gnu/11/f951 conftest.f -ffixed-form -quiet -dumpbase conftest.f -dumpbase-ext .f -mtune=generic -march=x86-64 -g -O2 -version -fintrinsic-modules-path /usr/lib/gcc/x86_64-linux-gnu/11/finclude -fpre-include=/usr/include/finclude/math-vector-fortran.h -o /tmp/ccZfShOp.s
+ /usr/lib/gcc/x86_64-linux-gnu/11/f951 conftest.f -ffixed-form -quiet -dumpbase conftest.f -dumpbase-ext .f -mtune=generic -march=x86-64 -g -O2 -version -fintrinsic-modules-path /usr/lib/gcc/x86_64-linux-gnu/11/finclude -fpre-include=/usr/include/finclude/math-vector-fortran.h -o /tmp/ccwdXyQ5.s
GNU Fortran (Ubuntu 11.3.0-1ubuntu1~22.04) version 11.3.0 (x86_64-linux-gnu)
compiled by GNU C version 11.3.0, GMP version 6.2.1, MPFR version 4.1.0, MPC version 1.2.1, isl version isl-0.24-GMP
GGC heuristics: --param ggc-min-expand=100 --param ggc-min-heapsize=131072
GNU Fortran2008 (Ubuntu 11.3.0-1ubuntu1~22.04) version 11.3.0 (x86_64-linux-gnu)
compiled by GNU C version 11.3.0, GMP version 6.2.1, MPFR version 4.1.0, MPC version 1.2.1, isl version isl-0.24-GMP
GGC heuristics: --param ggc-min-expand=100 --param ggc-min-heapsize=131072
- as -v --gdwarf-5 --64 -o /tmp/cccLZvdd.o /tmp/ccZfShOp.s
+ as -v --gdwarf-5 --64 -o /tmp/ccvRdOVi.o /tmp/ccwdXyQ5.s
GNU assembler version 2.38 (x86_64-linux-gnu) using BFD version (GNU Binutils for Ubuntu) 2.38
Reading specs from /usr/lib/gcc/x86_64-linux-gnu/11/libgfortran.spec
rename spec lib to liborig
- /usr/lib/gcc/x86_64-linux-gnu/11/collect2 -plugin /usr/lib/gcc/x86_64-linux-gnu/11/liblto_plugin.so -plugin-opt=/usr/lib/gcc/x86_64-linux-gnu/11/lto-wrapper -plugin-opt=-fresolution=/tmp/ccWK27vU.res -plugin-opt=-pass-through=-lgcc_s -plugin-opt=-pass-through=-lgcc -plugin-opt=-pass-through=-lquadmath -plugin-opt=-pass-through=-lm -plugin-opt=-pass-through=-lgcc_s -plugin-opt=-pass-through=-lgcc -plugin-opt=-pass-through=-lc -plugin-opt=-pass-through=-lgcc_s -plugin-opt=-pass-through=-lgcc --build-id --eh-frame-hdr -m elf_x86_64 --hash-style=gnu --as-needed -dynamic-linker /lib64/ld-linux-x86-64.so.2 -pie -z now -z relro -o conftest /usr/lib/gcc/x86_64-linux-gnu/11/../../../x86_64-linux-gnu/Scrt1.o /usr/lib/gcc/x86_64-linux-gnu/11/../../../x86_64-linux-gnu/crti.o /usr/lib/gcc/x86_64-linux-gnu/11/crtbeginS.o -L/usr/lib/gcc/x86_64-linux-gnu/11 -L/usr/lib/gcc/x86_64-linux-gnu/11/../../../x86_64-linux-gnu -L/usr/lib/gcc/x86_64-linux-gnu/11/../../../../lib -L/lib/x86_64-linux-gnu -L/lib/../lib -L/usr/lib/x86_64-linux-gnu -L/usr/lib/../lib -L/usr/lib/gcc/x86_64-linux-gnu/11/../../.. /tmp/cccLZvdd.o -lgfortran -lm -lgcc_s -lgcc -lquadmath -lm -lgcc_s -lgcc -lc -lgcc_s -lgcc /usr/lib/gcc/x86_64-linux-gnu/11/crtendS.o /usr/lib/gcc/x86_64-linux-gnu/11/../../../x86_64-linux-gnu/crtn.o
+ /usr/lib/gcc/x86_64-linux-gnu/11/collect2 -plugin /usr/lib/gcc/x86_64-linux-gnu/11/liblto_plugin.so -plugin-opt=/usr/lib/gcc/x86_64-linux-gnu/11/lto-wrapper -plugin-opt=-fresolution=/tmp/ccc9Df4T.res -plugin-opt=-pass-through=-lgcc_s -plugin-opt=-pass-through=-lgcc -plugin-opt=-pass-through=-lquadmath -plugin-opt=-pass-through=-lm -plugin-opt=-pass-through=-lgcc_s -plugin-opt=-pass-through=-lgcc -plugin-opt=-pass-through=-lc -plugin-opt=-pass-through=-lgcc_s -plugin-opt=-pass-through=-lgcc --build-id --eh-frame-hdr -m elf_x86_64 --hash-style=gnu --as-needed -dynamic-linker /lib64/ld-linux-x86-64.so.2 -pie -z now -z relro -o conftest /usr/lib/gcc/x86_64-linux-gnu/11/../../../x86_64-linux-gnu/Scrt1.o /usr/lib/gcc/x86_64-linux-gnu/11/../../../x86_64-linux-gnu/crti.o /usr/lib/gcc/x86_64-linux-gnu/11/crtbeginS.o -L/usr/lib/gcc/x86_64-linux-gnu/11 -L/usr/lib/gcc/x86_64-linux-gnu/11/../../../x86_64-linux-gnu -L/usr/lib/gcc/x86_64-linux-gnu/11/../../../../lib -L/lib/x86_64-linux-gnu -L/lib/../lib -L/usr/lib/x86_64-linux-gnu -L/usr/lib/../lib -L/usr/lib/gcc/x86_64-linux-gnu/11/../../.. /tmp/ccvRdOVi.o -lgfortran -lm -lgcc_s -lgcc -lquadmath -lm -lgcc_s -lgcc -lc -lgcc_s -lgcc /usr/lib/gcc/x86_64-linux-gnu/11/crtendS.o /usr/lib/gcc/x86_64-linux-gnu/11/../../../x86_64-linux-gnu/crtn.o
configure:5057: result: -v
configure:5059: checking for Fortran 77 libraries of g77
configure:5083: g77 -o conftest -g -O2 -v conftest.f
Using built-in specs.
Target: x86_64-linux-gnu
Thread model: posix
Supported LTO compression algorithms: zlib zstd
gcc version 11.3.0 (Ubuntu 11.3.0-1ubuntu1~22.04)
- /usr/lib/gcc/x86_64-linux-gnu/11/f951 conftest.f -ffixed-form -quiet -dumpbase conftest.f -dumpbase-ext .f -mtune=generic -march=x86-64 -g -O2 -version -fintrinsic-modules-path /usr/lib/gcc/x86_64-linux-gnu/11/finclude -fpre-include=/usr/include/finclude/math-vector-fortran.h -o /tmp/ccDGS2Sy.s
+ /usr/lib/gcc/x86_64-linux-gnu/11/f951 conftest.f -ffixed-form -quiet -dumpbase conftest.f -dumpbase-ext .f -mtune=generic -march=x86-64 -g -O2 -version -fintrinsic-modules-path /usr/lib/gcc/x86_64-linux-gnu/11/finclude -fpre-include=/usr/include/finclude/math-vector-fortran.h -o /tmp/ccYL7v6t.s
GNU Fortran (Ubuntu 11.3.0-1ubuntu1~22.04) version 11.3.0 (x86_64-linux-gnu)
compiled by GNU C version 11.3.0, GMP version 6.2.1, MPFR version 4.1.0, MPC version 1.2.1, isl version isl-0.24-GMP
GGC heuristics: --param ggc-min-expand=100 --param ggc-min-heapsize=131072
GNU Fortran2008 (Ubuntu 11.3.0-1ubuntu1~22.04) version 11.3.0 (x86_64-linux-gnu)
compiled by GNU C version 11.3.0, GMP version 6.2.1, MPFR version 4.1.0, MPC version 1.2.1, isl version isl-0.24-GMP
GGC heuristics: --param ggc-min-expand=100 --param ggc-min-heapsize=131072
- as -v --gdwarf-5 --64 -o /tmp/ccek5K8C.o /tmp/ccDGS2Sy.s
+ as -v --gdwarf-5 --64 -o /tmp/ccxbKpi8.o /tmp/ccYL7v6t.s
GNU assembler version 2.38 (x86_64-linux-gnu) using BFD version (GNU Binutils for Ubuntu) 2.38
Reading specs from /usr/lib/gcc/x86_64-linux-gnu/11/libgfortran.spec
rename spec lib to liborig
- /usr/lib/gcc/x86_64-linux-gnu/11/collect2 -plugin /usr/lib/gcc/x86_64-linux-gnu/11/liblto_plugin.so -plugin-opt=/usr/lib/gcc/x86_64-linux-gnu/11/lto-wrapper -plugin-opt=-fresolution=/tmp/ccxGZkok.res -plugin-opt=-pass-through=-lgcc_s -plugin-opt=-pass-through=-lgcc -plugin-opt=-pass-through=-lquadmath -plugin-opt=-pass-through=-lm -plugin-opt=-pass-through=-lgcc_s -plugin-opt=-pass-through=-lgcc -plugin-opt=-pass-through=-lc -plugin-opt=-pass-through=-lgcc_s -plugin-opt=-pass-through=-lgcc --build-id --eh-frame-hdr -m elf_x86_64 --hash-style=gnu --as-needed -dynamic-linker /lib64/ld-linux-x86-64.so.2 -pie -z now -z relro -o conftest /usr/lib/gcc/x86_64-linux-gnu/11/../../../x86_64-linux-gnu/Scrt1.o /usr/lib/gcc/x86_64-linux-gnu/11/../../../x86_64-linux-gnu/crti.o /usr/lib/gcc/x86_64-linux-gnu/11/crtbeginS.o -L/usr/lib/gcc/x86_64-linux-gnu/11 -L/usr/lib/gcc/x86_64-linux-gnu/11/../../../x86_64-linux-gnu -L/usr/lib/gcc/x86_64-linux-gnu/11/../../../../lib -L/lib/x86_64-linux-gnu -L/lib/../lib -L/usr/lib/x86_64-linux-gnu -L/usr/lib/../lib -L/usr/lib/gcc/x86_64-linux-gnu/11/../../.. /tmp/ccek5K8C.o -lgfortran -lm -lgcc_s -lgcc -lquadmath -lm -lgcc_s -lgcc -lc -lgcc_s -lgcc /usr/lib/gcc/x86_64-linux-gnu/11/crtendS.o /usr/lib/gcc/x86_64-linux-gnu/11/../../../x86_64-linux-gnu/crtn.o
+ /usr/lib/gcc/x86_64-linux-gnu/11/collect2 -plugin /usr/lib/gcc/x86_64-linux-gnu/11/liblto_plugin.so -plugin-opt=/usr/lib/gcc/x86_64-linux-gnu/11/lto-wrapper -plugin-opt=-fresolution=/tmp/ccOeG9UI.res -plugin-opt=-pass-through=-lgcc_s -plugin-opt=-pass-through=-lgcc -plugin-opt=-pass-through=-lquadmath -plugin-opt=-pass-through=-lm -plugin-opt=-pass-through=-lgcc_s -plugin-opt=-pass-through=-lgcc -plugin-opt=-pass-through=-lc -plugin-opt=-pass-through=-lgcc_s -plugin-opt=-pass-through=-lgcc --build-id --eh-frame-hdr -m elf_x86_64 --hash-style=gnu --as-needed -dynamic-linker /lib64/ld-linux-x86-64.so.2 -pie -z now -z relro -o conftest /usr/lib/gcc/x86_64-linux-gnu/11/../../../x86_64-linux-gnu/Scrt1.o /usr/lib/gcc/x86_64-linux-gnu/11/../../../x86_64-linux-gnu/crti.o /usr/lib/gcc/x86_64-linux-gnu/11/crtbeginS.o -L/usr/lib/gcc/x86_64-linux-gnu/11 -L/usr/lib/gcc/x86_64-linux-gnu/11/../../../x86_64-linux-gnu -L/usr/lib/gcc/x86_64-linux-gnu/11/../../../../lib -L/lib/x86_64-linux-gnu -L/lib/../lib -L/usr/lib/x86_64-linux-gnu -L/usr/lib/../lib -L/usr/lib/gcc/x86_64-linux-gnu/11/../../.. /tmp/ccxbKpi8.o -lgfortran -lm -lgcc_s -lgcc -lquadmath -lm -lgcc_s -lgcc -lc -lgcc_s -lgcc /usr/lib/gcc/x86_64-linux-gnu/11/crtendS.o /usr/lib/gcc/x86_64-linux-gnu/11/../../../x86_64-linux-gnu/crtn.o
configure:5299: result: -L/usr/lib/gcc/x86_64-linux-gnu/11 -L/usr/lib/gcc/x86_64-linux-gnu/11/../../../x86_64-linux-gnu -L/usr/lib/gcc/x86_64-linux-gnu/11/../../../../lib -L/lib/x86_64-linux-gnu -L/lib/../lib -L/usr/lib/x86_64-linux-gnu -L/usr/lib/../lib -L/usr/lib/gcc/x86_64-linux-gnu/11/../../.. -lgfortran -lm -lquadmath
configure:5362: checking how to print strings
configure:5389: result: printf
configure:5472: checking for gcc
configure:5493: found /bin/gcc
configure:5504: result: gcc
configure:5857: checking for C compiler version
configure:5866: gcc --version >&5
gcc (Ubuntu 11.3.0-1ubuntu1~22.04) 11.3.0
Copyright (C) 2021 Free Software Foundation, Inc.
This is free software; see the source for copying conditions. There is NO
warranty; not even for MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE.
configure:5877: $? = 0
configure:5866: gcc -v >&5
Using built-in specs.
COLLECT_GCC=gcc
COLLECT_LTO_WRAPPER=/usr/lib/gcc/x86_64-linux-gnu/11/lto-wrapper
OFFLOAD_TARGET_NAMES=nvptx-none:amdgcn-amdhsa
OFFLOAD_TARGET_DEFAULT=1
Target: x86_64-linux-gnu
Configured with: ../src/configure -v --with-pkgversion='Ubuntu 11.3.0-1ubuntu1~22.04' --with-bugurl=file:///usr/share/doc/gcc-11/README.Bugs --enable-languages=c,ada,c++,go,brig,d,fortran,objc,obj-c++,m2 --prefix=/usr --with-gcc-major-version-only --program-suffix=-11 --program-prefix=x86_64-linux-gnu- --enable-shared --enable-linker-build-id --libexecdir=/usr/lib --without-included-gettext --enable-threads=posix --libdir=/usr/lib --enable-nls --enable-bootstrap --enable-clocale=gnu --enable-libstdcxx-debug --enable-libstdcxx-time=yes --with-default-libstdcxx-abi=new --enable-gnu-unique-object --disable-vtable-verify --enable-plugin --enable-default-pie --with-system-zlib --enable-libphobos-checking=release --with-target-system-zlib=auto --enable-objc-gc=auto --enable-multiarch --disable-werror --enable-cet --with-arch-32=i686 --with-abi=m64 --with-multilib-list=m32,m64,mx32 --enable-multilib --with-tune=generic --enable-offload-targets=nvptx-none=/build/gcc-11-xKiWfi/gcc-11-11.3.0/debian/tmp-nvptx/usr,amdgcn-amdhsa=/build/gcc-11-xKiWfi/gcc-11-11.3.0/debian/tmp-gcn/usr --without-cuda-driver --enable-checking=release --build=x86_64-linux-gnu --host=x86_64-linux-gnu --target=x86_64-linux-gnu --with-build-config=bootstrap-lto-lean --enable-link-serialization=2
Thread model: posix
Supported LTO compression algorithms: zlib zstd
gcc version 11.3.0 (Ubuntu 11.3.0-1ubuntu1~22.04)
... rest of stderr output deleted ...
configure:5877: $? = 0
configure:5866: gcc -V >&5
gcc: error: unrecognized command-line option '-V'
gcc: fatal error: no input files
compilation terminated.
configure:5877: $? = 1
configure:5866: gcc -qversion >&5
gcc: error: unrecognized command-line option '-qversion'; did you mean '--version'?
gcc: fatal error: no input files
compilation terminated.
configure:5877: $? = 1
configure:5866: gcc -version >&5
gcc: error: unrecognized command-line option '-version'
gcc: fatal error: no input files
compilation terminated.
configure:5877: $? = 1
configure:5881: checking whether the compiler supports GNU C
configure:5901: gcc -c conftest.c >&5
configure:5901: $? = 0
configure:5911: result: yes
configure:5922: checking whether gcc accepts -g
configure:5943: gcc -c -g conftest.c >&5
configure:5943: $? = 0
configure:5987: result: yes
configure:6007: checking for gcc option to enable C11 features
configure:6022: gcc -c -g -O2 conftest.c >&5
configure:6022: $? = 0
configure:6040: result: none needed
configure:6156: checking whether gcc understands -c and -o together
configure:6179: gcc -c conftest.c -o conftest2.o
configure:6182: $? = 0
configure:6179: gcc -c conftest.c -o conftest2.o
configure:6182: $? = 0
configure:6194: result: yes
configure:6213: checking dependency style of gcc
configure:6325: result: gcc3
configure:6340: checking for a sed that does not truncate output
configure:6410: result: /bin/sed
configure:6428: checking for grep that handles long lines and -e
configure:6492: result: /bin/grep
configure:6497: checking for egrep
configure:6565: result: /bin/grep -E
configure:6570: checking for fgrep
configure:6638: result: /bin/grep -F
configure:6674: checking for ld used by gcc
configure:6742: result: /bin/ld
configure:6749: checking if the linker (/bin/ld) is GNU ld
configure:6765: result: yes
configure:6777: checking for BSD- or MS-compatible name lister (nm)
configure:6832: result: /bin/nm -B
configure:6972: checking the name lister (/bin/nm -B) interface
configure:6980: gcc -c -g -O2 conftest.c >&5
configure:6983: /bin/nm -B "conftest.o"
configure:6986: output
0000000000000000 B some_variable
configure:6993: result: BSD nm
configure:6996: checking whether ln -s works
configure:7000: result: yes
configure:7008: checking the maximum length of command line arguments
configure:7140: result: 1572864
configure:7188: checking how to convert x86_64-pc-linux-gnu file names to x86_64-pc-linux-gnu format
configure:7229: result: func_convert_file_noop
configure:7236: checking how to convert x86_64-pc-linux-gnu file names to toolchain format
configure:7257: result: func_convert_file_noop
configure:7264: checking for /bin/ld option to reload object files
configure:7272: result: -r
configure:7351: checking for objdump
configure:7372: found /bin/objdump
configure:7383: result: objdump
configure:7415: checking how to recognize dependent libraries
configure:7616: result: pass_all
configure:7706: checking for dlltool
configure:7741: result: no
configure:7771: checking how to associate runtime and link libraries
configure:7799: result: printf %s\n
configure:7865: checking for ar
configure:7886: found /bin/ar
configure:7897: result: ar
configure:7934: checking for archiver @FILE support
configure:7952: gcc -c -g -O2 conftest.c >&5
configure:7952: $? = 0
configure:7956: ar cr libconftest.a @conftest.lst >&5
configure:7959: $? = 0
configure:7964: ar cr libconftest.a @conftest.lst >&5
ar: conftest.o: No such file or directory
configure:7967: $? = 1
configure:7979: result: @
configure:8042: checking for strip
configure:8063: found /bin/strip
configure:8074: result: strip
configure:8151: checking for ranlib
configure:8172: found /bin/ranlib
configure:8183: result: ranlib
configure:8285: checking command to parse /bin/nm -B output from gcc object
configure:8439: gcc -c -g -O2 conftest.c >&5
configure:8442: $? = 0
configure:8446: /bin/nm -B conftest.o | sed -n -e 's/^.*[ ]\([ABCDGIRSTW][ABCDGIRSTW]*\)[ ][ ]*\([_A-Za-z][_A-Za-z0-9]*\)$/\1 \2 \2/p' | sed '/ __gnu_lto/d' > conftest.nm
configure:8512: gcc -o conftest -g -O2 conftest.c conftstm.o >&5
configure:8515: $? = 0
configure:8553: result: ok
configure:8600: checking for sysroot
configure:8631: result: no
configure:8638: checking for a working dd
configure:8682: result: /bin/dd
configure:8686: checking how to truncate binary pipes
configure:8702: result: /bin/dd bs=4096 count=1
configure:8839: gcc -c -g -O2 conftest.c >&5
configure:8842: $? = 0
configure:9039: checking for mt
configure:9060: found /bin/mt
configure:9071: result: mt
configure:9094: checking if mt is a manifest tool
configure:9101: mt '-?'
configure:9109: result: no
configure:9839: checking for stdio.h
configure:9839: gcc -c -g -O2 conftest.c >&5
configure:9839: $? = 0
configure:9839: result: yes
configure:9839: checking for stdlib.h
configure:9839: gcc -c -g -O2 conftest.c >&5
configure:9839: $? = 0
configure:9839: result: yes
configure:9839: checking for string.h
configure:9839: gcc -c -g -O2 conftest.c >&5
configure:9839: $? = 0
configure:9839: result: yes
configure:9839: checking for inttypes.h
configure:9839: gcc -c -g -O2 conftest.c >&5
configure:9839: $? = 0
configure:9839: result: yes
configure:9839: checking for stdint.h
configure:9839: gcc -c -g -O2 conftest.c >&5
configure:9839: $? = 0
configure:9839: result: yes
configure:9839: checking for strings.h
configure:9839: gcc -c -g -O2 conftest.c >&5
configure:9839: $? = 0
configure:9839: result: yes
configure:9839: checking for sys/stat.h
configure:9839: gcc -c -g -O2 conftest.c >&5
configure:9839: $? = 0
configure:9839: result: yes
configure:9839: checking for sys/types.h
configure:9839: gcc -c -g -O2 conftest.c >&5
configure:9839: $? = 0
configure:9839: result: yes
configure:9839: checking for unistd.h
configure:9839: gcc -c -g -O2 conftest.c >&5
configure:9839: $? = 0
configure:9839: result: yes
configure:9864: checking for dlfcn.h
configure:9864: gcc -c -g -O2 conftest.c >&5
configure:9864: $? = 0
configure:9864: result: yes
configure:10134: checking for objdir
configure:10150: result: .libs
configure:10414: checking if gcc supports -fno-rtti -fno-exceptions
configure:10433: gcc -c -g -O2 -fno-rtti -fno-exceptions conftest.c >&5
cc1: warning: command-line option '-fno-rtti' is valid for C++/D/ObjC++ but not for C
configure:10437: $? = 0
configure:10450: result: no
configure:10814: checking for gcc option to produce PIC
configure:10822: result: -fPIC -DPIC
configure:10830: checking if gcc PIC flag -fPIC -DPIC works
configure:10849: gcc -c -g -O2 -fPIC -DPIC -DPIC conftest.c >&5
configure:10853: $? = 0
configure:10866: result: yes
configure:10895: checking if gcc static flag -static works
configure:10924: result: yes
configure:10939: checking if gcc supports -c -o file.o
configure:10961: gcc -c -g -O2 -o out/conftest2.o conftest.c >&5
configure:10965: $? = 0
configure:10987: result: yes
configure:10995: checking if gcc supports -c -o file.o
configure:11043: result: yes
configure:11076: checking whether the gcc linker (/bin/ld -m elf_x86_64) supports shared libraries
configure:12346: result: yes
configure:12383: checking whether -lc should be explicitly linked in
configure:12392: gcc -c -g -O2 conftest.c >&5
configure:12395: $? = 0
configure:12410: gcc -shared -fPIC -DPIC conftest.o -v -Wl,-soname -Wl,conftest -o conftest 2\>\&1 \| /bin/grep -lc \>/dev/null 2\>\&1
configure:12413: $? = 0
configure:12427: result: no
configure:12587: checking dynamic linker characteristics
configure:13169: gcc -o conftest -g -O2 -Wl,-rpath -Wl,/foo conftest.c >&5
configure:13169: $? = 0
configure:13420: result: GNU/Linux ld.so
configure:13542: checking how to hardcode library paths into programs
configure:13567: result: immediate
configure:14119: checking whether stripping libraries is possible
configure:14124: result: yes
configure:14159: checking if libtool supports shared libraries
configure:14161: result: yes
configure:14164: checking whether to build shared libraries
configure:14189: result: yes
configure:14192: checking whether to build static libraries
configure:14196: result: no
configure:14219: checking how to run the C++ preprocessor
configure:14241: g++ -E conftest.cpp
configure:14241: $? = 0
configure:14256: g++ -E conftest.cpp
conftest.cpp:23:10: fatal error: ac_nonexistent.h: No such file or directory
23 | #include <ac_nonexistent.h>
| ^~~~~~~~~~~~~~~~~~
compilation terminated.
configure:14256: $? = 1
configure: failed program was:
| /* confdefs.h */
| #define PACKAGE_NAME "npstat"
| #define PACKAGE_TARNAME "npstat"
| #define PACKAGE_VERSION "5.10.0"
| #define PACKAGE_STRING "npstat 5.10.0"
| #define PACKAGE_BUGREPORT ""
| #define PACKAGE_URL ""
| #define PACKAGE "npstat"
| #define VERSION "5.10.0"
| #define HAVE_STDIO_H 1
| #define HAVE_STDLIB_H 1
| #define HAVE_STRING_H 1
| #define HAVE_INTTYPES_H 1
| #define HAVE_STDINT_H 1
| #define HAVE_STRINGS_H 1
| #define HAVE_SYS_STAT_H 1
| #define HAVE_SYS_TYPES_H 1
| #define HAVE_UNISTD_H 1
| #define STDC_HEADERS 1
| #define HAVE_DLFCN_H 1
| #define LT_OBJDIR ".libs/"
| /* end confdefs.h. */
| #include <ac_nonexistent.h>
configure:14283: result: g++ -E
configure:14297: g++ -E conftest.cpp
configure:14297: $? = 0
configure:14312: g++ -E conftest.cpp
conftest.cpp:23:10: fatal error: ac_nonexistent.h: No such file or directory
23 | #include <ac_nonexistent.h>
| ^~~~~~~~~~~~~~~~~~
compilation terminated.
configure:14312: $? = 1
configure: failed program was:
| /* confdefs.h */
| #define PACKAGE_NAME "npstat"
| #define PACKAGE_TARNAME "npstat"
| #define PACKAGE_VERSION "5.10.0"
| #define PACKAGE_STRING "npstat 5.10.0"
| #define PACKAGE_BUGREPORT ""
| #define PACKAGE_URL ""
| #define PACKAGE "npstat"
| #define VERSION "5.10.0"
| #define HAVE_STDIO_H 1
| #define HAVE_STDLIB_H 1
| #define HAVE_STRING_H 1
| #define HAVE_INTTYPES_H 1
| #define HAVE_STDINT_H 1
| #define HAVE_STRINGS_H 1
| #define HAVE_SYS_STAT_H 1
| #define HAVE_SYS_TYPES_H 1
| #define HAVE_UNISTD_H 1
| #define STDC_HEADERS 1
| #define HAVE_DLFCN_H 1
| #define LT_OBJDIR ".libs/"
| /* end confdefs.h. */
| #include <ac_nonexistent.h>
configure:14477: checking for ld used by g++
configure:14545: result: /bin/ld -m elf_x86_64
configure:14552: checking if the linker (/bin/ld -m elf_x86_64) is GNU ld
configure:14568: result: yes
configure:14623: checking whether the g++ linker (/bin/ld -m elf_x86_64) supports shared libraries
configure:15700: result: yes
configure:15736: g++ -c -std=c++11 -O3 -Wall -W -Werror conftest.cpp >&5
configure:15739: $? = 0
configure:16220: checking for g++ option to produce PIC
configure:16228: result: -fPIC -DPIC
configure:16236: checking if g++ PIC flag -fPIC -DPIC works
configure:16255: g++ -c -std=c++11 -O3 -Wall -W -Werror -fPIC -DPIC -DPIC conftest.cpp >&5
configure:16259: $? = 0
configure:16272: result: yes
configure:16295: checking if g++ static flag -static works
configure:16324: result: yes
configure:16336: checking if g++ supports -c -o file.o
configure:16358: g++ -c -std=c++11 -O3 -Wall -W -Werror -o out/conftest2.o conftest.cpp >&5
configure:16362: $? = 0
configure:16384: result: yes
configure:16389: checking if g++ supports -c -o file.o
configure:16437: result: yes
configure:16467: checking whether the g++ linker (/bin/ld -m elf_x86_64) supports shared libraries
configure:16510: result: yes
configure:16652: checking dynamic linker characteristics
configure:17412: result: GNU/Linux ld.so
configure:17477: checking how to hardcode library paths into programs
configure:17502: result: immediate
configure:17643: checking if libtool supports shared libraries
configure:17645: result: yes
configure:17648: checking whether to build shared libraries
configure:17672: result: yes
configure:17675: checking whether to build static libraries
configure:17679: result: no
configure:18037: checking for g77 option to produce PIC
configure:18045: result: -fPIC
configure:18053: checking if g77 PIC flag -fPIC works
configure:18072: g77 -c -g -O2 -fPIC conftest.f >&5
configure:18076: $? = 0
configure:18089: result: yes
configure:18112: checking if g77 static flag -static works
configure:18141: result: yes
configure:18153: checking if g77 supports -c -o file.o
configure:18175: g77 -c -g -O2 -o out/conftest2.o conftest.f >&5
configure:18179: $? = 0
configure:18201: result: yes
configure:18206: checking if g77 supports -c -o file.o
configure:18254: result: yes
configure:18284: checking whether the g77 linker (/bin/ld -m elf_x86_64) supports shared libraries
configure:19503: result: yes
configure:19645: checking dynamic linker characteristics
configure:20399: result: GNU/Linux ld.so
configure:20464: checking how to hardcode library paths into programs
configure:20489: result: immediate
configure:20681: checking that generated files are newer than configure
configure:20687: result: done
configure:20714: creating ./config.status
## ---------------------- ##
## Running config.status. ##
## ---------------------- ##
This file was extended by npstat config.status 5.10.0, which was
generated by GNU Autoconf 2.71. Invocation command line was
CONFIG_FILES =
CONFIG_HEADERS =
CONFIG_LINKS =
CONFIG_COMMANDS =
$ ./config.status
on dawn
config.status:1138: creating Makefile
config.status:1138: creating npstat/nm/Makefile
config.status:1138: creating npstat/rng/Makefile
config.status:1138: creating npstat/stat/Makefile
config.status:1138: creating npstat/wrap/Makefile
config.status:1138: creating npstat/interfaces/Makefile
config.status:1138: creating npstat/emsunfold/Makefile
config.status:1138: creating npstat/Makefile
config.status:1138: creating examples/C++/Makefile
config.status:1138: creating npstat/swig/Makefile
config.status:1138: creating npstat.pc
config.status:1310: executing depfiles commands
config.status:1387: cd npstat/nm && sed -e '/# am--include-marker/d' Makefile | make -f - am--depfiles
make: Nothing to be done for 'am--depfiles'.
config.status:1392: $? = 0
config.status:1387: cd npstat/rng && sed -e '/# am--include-marker/d' Makefile | make -f - am--depfiles
make: Nothing to be done for 'am--depfiles'.
config.status:1392: $? = 0
config.status:1387: cd npstat/stat && sed -e '/# am--include-marker/d' Makefile | make -f - am--depfiles
-make: Nothing to be done for 'am--depfiles'.
config.status:1392: $? = 0
config.status:1387: cd examples/C++ && sed -e '/# am--include-marker/d' Makefile | make -f - am--depfiles
make: Nothing to be done for 'am--depfiles'.
config.status:1392: $? = 0
config.status:1387: cd npstat/swig && sed -e '/# am--include-marker/d' Makefile | make -f - am--depfiles
make: Nothing to be done for 'am--depfiles'.
config.status:1392: $? = 0
config.status:1310: executing libtool commands
## ---------------- ##
## Cache variables. ##
## ---------------- ##
ac_cv_build=x86_64-pc-linux-gnu
ac_cv_c_compiler_gnu=yes
ac_cv_cxx_compiler_gnu=yes
ac_cv_env_CCC_set=
ac_cv_env_CCC_value=
ac_cv_env_CC_set=
ac_cv_env_CC_value=
ac_cv_env_CFLAGS_set=
ac_cv_env_CFLAGS_value=
ac_cv_env_CPPFLAGS_set=
ac_cv_env_CPPFLAGS_value=
ac_cv_env_CXXCPP_set=
ac_cv_env_CXXCPP_value=
ac_cv_env_CXXFLAGS_set=set
ac_cv_env_CXXFLAGS_value='-std=c++11 -O3 -Wall -W -Werror'
ac_cv_env_CXX_set=
ac_cv_env_CXX_value=
ac_cv_env_DEPS_CFLAGS_set=
ac_cv_env_DEPS_CFLAGS_value=
ac_cv_env_DEPS_LIBS_set=
ac_cv_env_DEPS_LIBS_value=
ac_cv_env_F77_set=
ac_cv_env_F77_value=
ac_cv_env_FFLAGS_set=
ac_cv_env_FFLAGS_value=
ac_cv_env_LDFLAGS_set=
ac_cv_env_LDFLAGS_value=
ac_cv_env_LIBS_set=
ac_cv_env_LIBS_value=
ac_cv_env_LT_SYS_LIBRARY_PATH_set=
ac_cv_env_LT_SYS_LIBRARY_PATH_value=
ac_cv_env_PKG_CONFIG_LIBDIR_set=
ac_cv_env_PKG_CONFIG_LIBDIR_value=
ac_cv_env_PKG_CONFIG_PATH_set=set
ac_cv_env_PKG_CONFIG_PATH_value=/usr/local/lib/pkgconfig
ac_cv_env_PKG_CONFIG_set=
ac_cv_env_PKG_CONFIG_value=
ac_cv_env_build_alias_set=
ac_cv_env_build_alias_value=
ac_cv_env_host_alias_set=
ac_cv_env_host_alias_value=
ac_cv_env_target_alias_set=
ac_cv_env_target_alias_value=
ac_cv_f77_compiler_gnu=yes
ac_cv_f77_libs=' -L/usr/lib/gcc/x86_64-linux-gnu/11 -L/usr/lib/gcc/x86_64-linux-gnu/11/../../../x86_64-linux-gnu -L/usr/lib/gcc/x86_64-linux-gnu/11/../../../../lib -L/lib/x86_64-linux-gnu -L/lib/../lib -L/usr/lib/x86_64-linux-gnu -L/usr/lib/../lib -L/usr/lib/gcc/x86_64-linux-gnu/11/../../.. -lgfortran -lm -lquadmath'
ac_cv_header_dlfcn_h=yes
ac_cv_header_inttypes_h=yes
ac_cv_header_stdint_h=yes
ac_cv_header_stdio_h=yes
ac_cv_header_stdlib_h=yes
ac_cv_header_string_h=yes
ac_cv_header_strings_h=yes
ac_cv_header_sys_stat_h=yes
ac_cv_header_sys_types_h=yes
ac_cv_header_unistd_h=yes
ac_cv_host=x86_64-pc-linux-gnu
ac_cv_objext=o
ac_cv_path_EGREP='/bin/grep -E'
ac_cv_path_FGREP='/bin/grep -F'
ac_cv_path_GREP=/bin/grep
ac_cv_path_SED=/bin/sed
ac_cv_path_ac_pt_PKG_CONFIG=/bin/pkg-config
ac_cv_path_install='/bin/install -c'
ac_cv_path_lt_DD=/bin/dd
ac_cv_path_mkdir=/bin/mkdir
ac_cv_prog_AWK=mawk
ac_cv_prog_CXXCPP='g++ -E'
ac_cv_prog_ac_ct_AR=ar
ac_cv_prog_ac_ct_CC=gcc
ac_cv_prog_ac_ct_CXX=g++
ac_cv_prog_ac_ct_F77=g77
ac_cv_prog_ac_ct_MANIFEST_TOOL=mt
ac_cv_prog_ac_ct_OBJDUMP=objdump
ac_cv_prog_ac_ct_RANLIB=ranlib
ac_cv_prog_ac_ct_STRIP=strip
ac_cv_prog_cc_c11=
ac_cv_prog_cc_g=yes
ac_cv_prog_cc_stdc=
ac_cv_prog_cxx_11=no
ac_cv_prog_cxx_g=yes
ac_cv_prog_cxx_stdcxx=
ac_cv_prog_f77_g=yes
ac_cv_prog_f77_v=-v
ac_cv_prog_make_make_set=yes
am_cv_CC_dependencies_compiler_type=gcc3
am_cv_CXX_dependencies_compiler_type=gcc3
am_cv_make_support_nested_variables=yes
am_cv_prog_cc_c_o=yes
lt_cv_ar_at_file=@
lt_cv_archive_cmds_need_lc=no
lt_cv_deplibs_check_method=pass_all
lt_cv_file_magic_cmd='$MAGIC_CMD'
lt_cv_file_magic_test_file=
lt_cv_ld_reload_flag=-r
lt_cv_nm_interface='BSD nm'
lt_cv_objdir=.libs
lt_cv_path_LD=/bin/ld
lt_cv_path_LDCXX='/bin/ld -m elf_x86_64'
lt_cv_path_NM='/bin/nm -B'
lt_cv_path_mainfest_tool=no
lt_cv_prog_compiler_c_o=yes
lt_cv_prog_compiler_c_o_CXX=yes
lt_cv_prog_compiler_c_o_F77=yes
lt_cv_prog_compiler_pic='-fPIC -DPIC'
lt_cv_prog_compiler_pic_CXX='-fPIC -DPIC'
lt_cv_prog_compiler_pic_F77=-fPIC
lt_cv_prog_compiler_pic_works=yes
lt_cv_prog_compiler_pic_works_CXX=yes
lt_cv_prog_compiler_pic_works_F77=yes
lt_cv_prog_compiler_rtti_exceptions=no
lt_cv_prog_compiler_static_works=yes
lt_cv_prog_compiler_static_works_CXX=yes
lt_cv_prog_compiler_static_works_F77=yes
lt_cv_prog_gnu_ld=yes
lt_cv_prog_gnu_ldcxx=yes
lt_cv_sharedlib_from_linklib_cmd='printf %s\n'
lt_cv_shlibpath_overrides_runpath=yes
lt_cv_sys_global_symbol_pipe='sed -n -e '\''s/^.*[ ]\([ABCDGIRSTW][ABCDGIRSTW]*\)[ ][ ]*\([_A-Za-z][_A-Za-z0-9]*\)$/\1 \2 \2/p'\'' | sed '\''/ __gnu_lto/d'\'''
lt_cv_sys_global_symbol_to_c_name_address='sed -n -e '\''s/^: \(.*\) .*$/ {"\1", (void *) 0},/p'\'' -e '\''s/^[ABCDGIRSTW][ABCDGIRSTW]* .* \(.*\)$/ {"\1", (void *) \&\1},/p'\'''
lt_cv_sys_global_symbol_to_c_name_address_lib_prefix='sed -n -e '\''s/^: \(.*\) .*$/ {"\1", (void *) 0},/p'\'' -e '\''s/^[ABCDGIRSTW][ABCDGIRSTW]* .* \(lib.*\)$/ {"\1", (void *) \&\1},/p'\'' -e '\''s/^[ABCDGIRSTW][ABCDGIRSTW]* .* \(.*\)$/ {"lib\1", (void *) \&\1},/p'\'''
lt_cv_sys_global_symbol_to_cdecl='sed -n -e '\''s/^T .* \(.*\)$/extern int \1();/p'\'' -e '\''s/^[ABCDGIRSTW][ABCDGIRSTW]* .* \(.*\)$/extern char \1;/p'\'''
lt_cv_sys_global_symbol_to_import=
lt_cv_sys_max_cmd_len=1572864
lt_cv_to_host_file_cmd=func_convert_file_noop
lt_cv_to_tool_file_cmd=func_convert_file_noop
lt_cv_truncate_bin='/bin/dd bs=4096 count=1'
pkg_cv_DEPS_CFLAGS=-I/usr/local/include
pkg_cv_DEPS_LIBS='-L/usr/local/lib -lfftw3 -lgeners -lkstest'
## ----------------- ##
## Output variables. ##
## ----------------- ##
ACLOCAL='${SHELL} '\''/home/igv/Hepforge/npstat/trunk/missing'\'' aclocal-1.16'
AMDEPBACKSLASH='\'
AMDEP_FALSE='#'
AMDEP_TRUE=''
AMTAR='$${TAR-tar}'
AM_BACKSLASH='\'
AM_DEFAULT_V='$(AM_DEFAULT_VERBOSITY)'
AM_DEFAULT_VERBOSITY='1'
AM_V='$(V)'
AR='ar'
AUTOCONF='${SHELL} '\''/home/igv/Hepforge/npstat/trunk/missing'\'' autoconf'
AUTOHEADER='${SHELL} '\''/home/igv/Hepforge/npstat/trunk/missing'\'' autoheader'
AUTOMAKE='${SHELL} '\''/home/igv/Hepforge/npstat/trunk/missing'\'' automake-1.16'
AWK='mawk'
CC='gcc'
CCDEPMODE='depmode=gcc3'
CFLAGS='-g -O2'
CPPFLAGS=''
CSCOPE='cscope'
CTAGS='ctags'
CXX='g++'
CXXCPP='g++ -E'
CXXDEPMODE='depmode=gcc3'
CXXFLAGS='-std=c++11 -O3 -Wall -W -Werror'
CYGPATH_W='echo'
DEFS='-DPACKAGE_NAME=\"npstat\" -DPACKAGE_TARNAME=\"npstat\" -DPACKAGE_VERSION=\"5.10.0\" -DPACKAGE_STRING=\"npstat\ 5.10.0\" -DPACKAGE_BUGREPORT=\"\" -DPACKAGE_URL=\"\" -DPACKAGE=\"npstat\" -DVERSION=\"5.10.0\" -DHAVE_STDIO_H=1 -DHAVE_STDLIB_H=1 -DHAVE_STRING_H=1 -DHAVE_INTTYPES_H=1 -DHAVE_STDINT_H=1 -DHAVE_STRINGS_H=1 -DHAVE_SYS_STAT_H=1 -DHAVE_SYS_TYPES_H=1 -DHAVE_UNISTD_H=1 -DSTDC_HEADERS=1 -DHAVE_DLFCN_H=1 -DLT_OBJDIR=\".libs/\"'
DEPDIR='.deps'
DEPS_CFLAGS='-I/usr/local/include'
DEPS_LIBS='-L/usr/local/lib -lfftw3 -lgeners -lkstest'
DLLTOOL='false'
DSYMUTIL=''
DUMPBIN=''
ECHO_C=''
ECHO_N='-n'
ECHO_T=''
EGREP='/bin/grep -E'
ETAGS='etags'
EXEEXT=''
F77='g77'
FFLAGS='-g -O2'
FGREP='/bin/grep -F'
FLIBS=' -L/usr/lib/gcc/x86_64-linux-gnu/11 -L/usr/lib/gcc/x86_64-linux-gnu/11/../../../x86_64-linux-gnu -L/usr/lib/gcc/x86_64-linux-gnu/11/../../../../lib -L/lib/x86_64-linux-gnu -L/lib/../lib -L/usr/lib/x86_64-linux-gnu -L/usr/lib/../lib -L/usr/lib/gcc/x86_64-linux-gnu/11/../../.. -lgfortran -lm -lquadmath'
GREP='/bin/grep'
INSTALL_DATA='${INSTALL} -m 644'
INSTALL_PROGRAM='${INSTALL}'
INSTALL_SCRIPT='${INSTALL}'
INSTALL_STRIP_PROGRAM='$(install_sh) -c -s'
LD='/bin/ld -m elf_x86_64'
LDFLAGS=''
LIBOBJS=''
LIBS=''
LIBTOOL='$(SHELL) $(top_builddir)/libtool'
LIPO=''
LN_S='ln -s'
LTLIBOBJS=''
LT_SYS_LIBRARY_PATH=''
MAKEINFO='${SHELL} '\''/home/igv/Hepforge/npstat/trunk/missing'\'' makeinfo'
MANIFEST_TOOL=':'
MKDIR_P='/bin/mkdir -p'
NM='/bin/nm -B'
NMEDIT=''
OBJDUMP='objdump'
OBJEXT='o'
OTOOL64=''
OTOOL=''
PACKAGE='npstat'
PACKAGE_BUGREPORT=''
PACKAGE_NAME='npstat'
PACKAGE_STRING='npstat 5.10.0'
PACKAGE_TARNAME='npstat'
PACKAGE_URL=''
PACKAGE_VERSION='5.10.0'
PATH_SEPARATOR=':'
PKG_CONFIG='/bin/pkg-config'
PKG_CONFIG_LIBDIR=''
PKG_CONFIG_PATH='/usr/local/lib/pkgconfig'
RANLIB='ranlib'
SED='/bin/sed'
SET_MAKE=''
SHELL='/bin/bash'
STRIP='strip'
VERSION='5.10.0'
ac_ct_AR='ar'
ac_ct_CC='gcc'
ac_ct_CXX='g++'
ac_ct_DUMPBIN=''
ac_ct_F77='g77'
am__EXEEXT_FALSE=''
am__EXEEXT_TRUE='#'
am__fastdepCC_FALSE='#'
am__fastdepCC_TRUE=''
am__fastdepCXX_FALSE='#'
am__fastdepCXX_TRUE=''
am__include='include'
am__isrc=''
am__leading_dot='.'
am__nodep='_no'
am__quote=''
am__tar='$${TAR-tar} chof - "$$tardir"'
am__untar='$${TAR-tar} xf -'
bindir='${exec_prefix}/bin'
build='x86_64-pc-linux-gnu'
build_alias=''
build_cpu='x86_64'
build_os='linux-gnu'
build_vendor='pc'
datadir='${datarootdir}'
datarootdir='${prefix}/share'
docdir='${datarootdir}/doc/${PACKAGE_TARNAME}'
dvidir='${docdir}'
exec_prefix='${prefix}'
host='x86_64-pc-linux-gnu'
host_alias=''
host_cpu='x86_64'
host_os='linux-gnu'
host_vendor='pc'
htmldir='${docdir}'
includedir='${prefix}/include'
infodir='${datarootdir}/info'
install_sh='${SHELL} /home/igv/Hepforge/npstat/trunk/install-sh'
libdir='${exec_prefix}/lib'
libexecdir='${exec_prefix}/libexec'
localedir='${datarootdir}/locale'
localstatedir='${prefix}/var'
mandir='${datarootdir}/man'
mkdir_p='$(MKDIR_P)'
oldincludedir='/usr/include'
pdfdir='${docdir}'
prefix='/usr/local'
program_transform_name='s,x,x,'
psdir='${docdir}'
runstatedir='${localstatedir}/run'
sbindir='${exec_prefix}/sbin'
sharedstatedir='${prefix}/com'
sysconfdir='${prefix}/etc'
target_alias=''
## ----------- ##
## confdefs.h. ##
## ----------- ##
/* confdefs.h */
#define PACKAGE_NAME "npstat"
#define PACKAGE_TARNAME "npstat"
#define PACKAGE_VERSION "5.10.0"
#define PACKAGE_STRING "npstat 5.10.0"
#define PACKAGE_BUGREPORT ""
#define PACKAGE_URL ""
#define PACKAGE "npstat"
#define VERSION "5.10.0"
#define HAVE_STDIO_H 1
#define HAVE_STDLIB_H 1
#define HAVE_STRING_H 1
#define HAVE_INTTYPES_H 1
#define HAVE_STDINT_H 1
#define HAVE_STRINGS_H 1
#define HAVE_SYS_STAT_H 1
#define HAVE_SYS_TYPES_H 1
#define HAVE_UNISTD_H 1
#define STDC_HEADERS 1
#define HAVE_DLFCN_H 1
#define LT_OBJDIR ".libs/"
configure: exit 0
Index: trunk/autom4te.cache/requests
===================================================================
--- trunk/autom4te.cache/requests (revision 896)
+++ trunk/autom4te.cache/requests (revision 897)
@@ -1,473 +1,473 @@
# This file was generated by Autom4te 2.71.
# It contains the lists of macros which have been traced.
# It can be safely removed.
@request = (
bless( [
'0',
1,
[
'/usr/share/autoconf'
],
[
'/usr/share/autoconf/m4sugar/m4sugar.m4',
'/usr/share/autoconf/m4sugar/m4sh.m4',
'/usr/share/autoconf/autoconf/autoconf.m4',
'aclocal.m4',
'/dev/null'
],
{
- 'AM_POT_TOOLS' => 1,
- 'AM_PROG_CXX_C_O' => 1,
- 'include' => 1,
- 'AC_SUBST_TRACE' => 1,
- 'm4_pattern_forbid' => 1,
- 'AM_AUTOMAKE_VERSION' => 1,
- 'AC_FC_SRCEXT' => 1,
+ 'AC_INIT' => 1,
+ 'GTK_DOC_CHECK' => 1,
+ 'AM_PATH_GUILE' => 1,
+ 'm4_sinclude' => 1,
+ 'AM_PROG_CC_C_O' => 1,
+ 'AM_PROG_MKDIR_P' => 1,
'AC_CONFIG_LINKS' => 1,
- 'AM_GNU_GETTEXT_INTL_SUBDIR' => 1,
- 'AC_DEFINE_TRACE_LITERAL' => 1,
- '_AM_COND_IF' => 1,
- 'AH_OUTPUT' => 1,
- '_AM_COND_ENDIF' => 1,
- 'AM_PROG_LIBTOOL' => 1,
+ 'AC_SUBST' => 1,
+ 'AC_FC_FREEFORM' => 1,
'define' => 1,
- 'AM_INIT_AUTOMAKE' => 1,
+ 'AM_PROG_FC_C_O' => 1,
+ 'AC_FC_PP_DEFINE' => 1,
+ 'AC_CANONICAL_BUILD' => 1,
+ '_AM_SUBST_NOTMAKE' => 1,
+ 'AC_LIBSOURCE' => 1,
+ 'AC_REQUIRE_AUX_FILE' => 1,
+ 'LT_CONFIG_LTDL_DIR' => 1,
+ 'LT_INIT' => 1,
+ 'm4_pattern_forbid' => 1,
+ 'AM_MAINTAINER_MODE' => 1,
+ 'm4_pattern_allow' => 1,
+ '_LT_AC_TAGCONFIG' => 1,
+ 'LT_SUPPORTED_TAG' => 1,
'AM_CONDITIONAL' => 1,
- 'AC_CANONICAL_HOST' => 1,
- 'AC_CONFIG_HEADERS' => 1,
- 'AM_ENABLE_MULTILIB' => 1,
- 'AM_PROG_CC_C_O' => 1,
- 'AM_PROG_F77_C_O' => 1,
- 'AC_CONFIG_LIBOBJ_DIR' => 1,
- 'AU_DEFINE' => 1,
'AM_PROG_AR' => 1,
- 'm4_pattern_allow' => 1,
- 'IT_PROG_INTLTOOL' => 1,
- 'AM_PROG_MOC' => 1,
- 'LT_INIT' => 1,
- 'AC_CANONICAL_TARGET' => 1,
+ 'AC_CONFIG_LIBOBJ_DIR' => 1,
'AM_MAKEFILE_INCLUDE' => 1,
- 'AC_PROG_LIBTOOL' => 1,
- 'LT_SUPPORTED_TAG' => 1,
- 'AM_PROG_MKDIR_P' => 1,
- 'AC_FC_FREEFORM' => 1,
- 'AC_CONFIG_AUX_DIR' => 1,
- 'sinclude' => 1,
- 'AC_CONFIG_FILES' => 1,
- '_AM_SUBST_NOTMAKE' => 1,
- 'GTK_DOC_CHECK' => 1,
- 'AM_NLS' => 1,
- 'AM_SILENT_RULES' => 1,
- 'AM_PROG_FC_C_O' => 1,
- 'AC_CONFIG_MACRO_DIR_TRACE' => 1,
+ 'AC_FC_SRCEXT' => 1,
'AC_CANONICAL_SYSTEM' => 1,
- 'AM_MAINTAINER_MODE' => 1,
- 'AC_CONFIG_SUBDIRS' => 1,
- '_AM_COND_ELSE' => 1,
'AM_XGETTEXT_OPTION' => 1,
- 'AC_FC_PP_SRCEXT' => 1,
- 'AC_REQUIRE_AUX_FILE' => 1,
- '_LT_AC_TAGCONFIG' => 1,
+ '_AM_COND_ELSE' => 1,
'_m4_warn' => 1,
- 'm4_define' => 1,
- 'AM_PATH_GUILE' => 1,
- 'AC_INIT' => 1,
- 'AC_CANONICAL_BUILD' => 1,
- 'AC_SUBST' => 1,
- 'LT_CONFIG_LTDL_DIR' => 1,
- 'AM_GNU_GETTEXT' => 1,
- 'm4_sinclude' => 1,
- 'AC_LIBSOURCE' => 1,
+ 'IT_PROG_INTLTOOL' => 1,
+ 'sinclude' => 1,
+ 'AC_PROG_LIBTOOL' => 1,
'_AM_MAKEFILE_INCLUDE' => 1,
- 'm4_include' => 1,
+ 'AC_CONFIG_FILES' => 1,
+ 'AC_CONFIG_HEADERS' => 1,
+ 'AC_CANONICAL_HOST' => 1,
+ 'AU_DEFINE' => 1,
+ 'AC_CONFIG_SUBDIRS' => 1,
'AM_EXTRA_RECURSIVE_TARGETS' => 1,
- 'AC_FC_PP_DEFINE' => 1
+ 'AM_PROG_CXX_C_O' => 1,
+ 'AH_OUTPUT' => 1,
+ 'AM_PROG_MOC' => 1,
+ 'AM_POT_TOOLS' => 1,
+ 'AM_GNU_GETTEXT_INTL_SUBDIR' => 1,
+ 'include' => 1,
+ '_AM_COND_ENDIF' => 1,
+ 'AC_CANONICAL_TARGET' => 1,
+ 'm4_define' => 1,
+ 'AM_PROG_F77_C_O' => 1,
+ 'AC_CONFIG_AUX_DIR' => 1,
+ 'AM_INIT_AUTOMAKE' => 1,
+ 'AC_CONFIG_MACRO_DIR_TRACE' => 1,
+ 'AM_PROG_LIBTOOL' => 1,
+ 'AM_ENABLE_MULTILIB' => 1,
+ 'm4_include' => 1,
+ 'AM_SILENT_RULES' => 1,
+ 'AM_GNU_GETTEXT' => 1,
+ 'AC_FC_PP_SRCEXT' => 1,
+ 'AC_SUBST_TRACE' => 1,
+ 'AM_NLS' => 1,
+ '_AM_COND_IF' => 1,
+ 'AM_AUTOMAKE_VERSION' => 1,
+ 'AC_DEFINE_TRACE_LITERAL' => 1
}
], 'Autom4te::Request' ),
bless( [
'1',
1,
[
'/usr/share/autoconf'
],
[
'/usr/share/autoconf/autoconf/autoconf.m4f',
'/usr/share/aclocal-1.16/internal/ac-config-macro-dirs.m4',
'/usr/share/aclocal/ltargz.m4',
'/usr/share/aclocal/ltdl.m4',
'/usr/share/aclocal/pkg.m4',
'/usr/share/aclocal-1.16/amversion.m4',
'/usr/share/aclocal-1.16/auxdir.m4',
'/usr/share/aclocal-1.16/cond.m4',
'/usr/share/aclocal-1.16/depend.m4',
'/usr/share/aclocal-1.16/depout.m4',
'/usr/share/aclocal-1.16/extra-recurs.m4',
'/usr/share/aclocal-1.16/init.m4',
'/usr/share/aclocal-1.16/install-sh.m4',
'/usr/share/aclocal-1.16/lead-dot.m4',
'/usr/share/aclocal-1.16/make.m4',
'/usr/share/aclocal-1.16/missing.m4',
'/usr/share/aclocal-1.16/options.m4',
'/usr/share/aclocal-1.16/prog-cc-c-o.m4',
'/usr/share/aclocal-1.16/runlog.m4',
'/usr/share/aclocal-1.16/sanity.m4',
'/usr/share/aclocal-1.16/silent.m4',
'/usr/share/aclocal-1.16/strip.m4',
'/usr/share/aclocal-1.16/substnot.m4',
'/usr/share/aclocal-1.16/tar.m4',
'm4/libtool.m4',
'm4/ltoptions.m4',
'm4/ltsugar.m4',
'm4/ltversion.m4',
'm4/lt~obsolete.m4',
'configure.ac'
],
{
- 'AC_LIBTOOL_PROG_LD_HARDCODE_LIBPATH' => 1,
- 'LT_AC_PROG_EGREP' => 1,
- '_AM_SET_OPTION' => 1,
- 'AM_SET_CURRENT_AUTOMAKE_VERSION' => 1,
- 'AC_DISABLE_STATIC' => 1,
- '_LT_AC_TRY_DLOPEN_SELF' => 1,
- '_AM_SUBST_NOTMAKE' => 1,
- 'AU_DEFUN' => 1,
- 'AC_DEFUN' => 1,
- 'AM_OUTPUT_DEPENDENCY_COMMANDS' => 1,
- 'AC_LIBTOOL_DLOPEN' => 1,
- 'AM_PROG_INSTALL_SH' => 1,
- 'PKG_CHECK_MODULES_STATIC' => 1,
- 'AC_ENABLE_SHARED' => 1,
- '_LT_AC_LANG_RC_CONFIG' => 1,
- 'AM_DISABLE_STATIC' => 1,
- 'AM_PROG_CC_C_O' => 1,
+ 'PKG_NOARCH_INSTALLDIR' => 1,
'LTSUGAR_VERSION' => 1,
- 'AC_LIBTOOL_F77' => 1,
- 'AM_INIT_AUTOMAKE' => 1,
- 'LT_OUTPUT' => 1,
- 'AC_PROG_LD_RELOAD_FLAG' => 1,
- 'AM_ENABLE_SHARED' => 1,
- 'LT_WITH_LTDL' => 1,
- 'AC_LTDL_SHLIBPATH' => 1,
- 'LT_CONFIG_LTDL_DIR' => 1,
+ 'AC_ENABLE_FAST_INSTALL' => 1,
+ 'AM_PROG_INSTALL_STRIP' => 1,
+ '_LT_COMPILER_BOILERPLATE' => 1,
+ 'AM_SUBST_NOTMAKE' => 1,
+ '_LT_AC_TAGCONFIG' => 1,
+ 'AC_LIBTOOL_SYS_MAX_CMD_LEN' => 1,
+ '_AM_PROG_TAR' => 1,
'AC_LIBTOOL_OBJDIR' => 1,
- 'LT_LIB_M' => 1,
- 'PKG_INSTALLDIR' => 1,
- '_LT_PREPARE_SED_QUOTE_VARS' => 1,
- '_LT_AC_FILE_LTDLL_C' => 1,
- '_LT_LIBOBJ' => 1,
- '_LTDL_SETUP' => 1,
- 'AM_SET_DEPDIR' => 1,
+ '_AC_AM_CONFIG_HEADER_HOOK' => 1,
+ 'AC_LIBTOOL_SYS_OLD_ARCHIVE' => 1,
'AC_LIBTOOL_COMPILER_OPTION' => 1,
+ 'LT_LIB_DLLOAD' => 1,
+ '_LT_LINKER_OPTION' => 1,
+ 'AC_LTDL_PREOPEN' => 1,
+ 'AC_LIBTOOL_F77' => 1,
+ 'AC_PROG_LIBTOOL' => 1,
+ 'AM_MISSING_PROG' => 1,
+ 'AM_SET_LEADING_DOT' => 1,
+ 'AC_PATH_MAGIC' => 1,
+ '_LT_PROG_ECHO_BACKSLASH' => 1,
'AC_LIBTOOL_LANG_GCJ_CONFIG' => 1,
- 'AC_LIBTOOL_WIN32_DLL' => 1,
- 'AM_PROG_INSTALL_STRIP' => 1,
- '_AM_OUTPUT_DEPENDENCY_COMMANDS' => 1,
- 'AM_RUN_LOG' => 1,
+ 'AC_LIBTOOL_LINKER_OPTION' => 1,
+ 'AC_LIBTOOL_LANG_C_CONFIG' => 1,
+ '_AM_SET_OPTIONS' => 1,
+ 'AC_LIBTOOL_SYS_DYNAMIC_LINKER' => 1,
+ 'LT_PATH_LD' => 1,
+ 'LT_PATH_NM' => 1,
+ 'AC_LTDL_SHLIBEXT' => 1,
'LTDL_INSTALLABLE' => 1,
- 'PKG_NOARCH_INSTALLDIR' => 1,
- '_LT_AC_CHECK_DLFCN' => 1,
- 'LT_SYS_DLOPEN_SELF' => 1,
- 'AC_LIBTOOL_PICMODE' => 1,
- 'AC_LTDL_DLSYM_USCORE' => 1,
- 'LTOPTIONS_VERSION' => 1,
- '_AC_AM_CONFIG_HEADER_HOOK' => 1,
- 'AC_LIBTOOL_GCJ' => 1,
- 'AC_LTDL_ENABLE_INSTALL' => 1,
- 'AC_LIBLTDL_INSTALLABLE' => 1,
+ '_PKG_SHORT_ERRORS_SUPPORTED' => 1,
+ '_LT_AC_LANG_RC_CONFIG' => 1,
+ '_AM_IF_OPTION' => 1,
+ 'AC_LIBTOOL_SYS_GLOBAL_SYMBOL_PIPE' => 1,
+ 'LT_LIB_M' => 1,
+ 'include' => 1,
'_LT_REQUIRED_DARWIN_CHECKS' => 1,
- 'AC_PROG_NM' => 1,
- 'LT_SYS_MODULE_EXT' => 1,
+ '_LT_LIBOBJ' => 1,
+ 'AC_ENABLE_SHARED' => 1,
+ '_LT_AC_TRY_DLOPEN_SELF' => 1,
+ 'AM_EXTRA_RECURSIVE_TARGETS' => 1,
+ 'AC_DEFUN_ONCE' => 1,
+ 'AC_LTDL_OBJDIR' => 1,
+ 'AC_LIBLTDL_CONVENIENCE' => 1,
+ '_LT_LINKER_BOILERPLATE' => 1,
+ 'AC_LTDL_SYSSEARCHPATH' => 1,
+ 'AM_ENABLE_STATIC' => 1,
+ 'LTVERSION_VERSION' => 1,
+ 'AC_LIBTOOL_PROG_LD_HARDCODE_LIBPATH' => 1,
+ 'AC_PROG_EGREP' => 1,
+ 'LT_FUNC_ARGZ' => 1,
+ 'AC_CONFIG_MACRO_DIR_TRACE' => 1,
+ '_LT_AC_LANG_CXX_CONFIG' => 1,
'LT_PROG_RC' => 1,
- 'LT_SUPPORTED_TAG' => 1,
- 'LT_SYS_SYMBOL_USCORE' => 1,
- 'AM_AUX_DIR_EXPAND' => 1,
- '_LT_AC_LANG_F77' => 1,
+ 'AC_PROG_LD_GNU' => 1,
'AM_DISABLE_SHARED' => 1,
+ '_LT_AC_LANG_GCJ' => 1,
+ 'AC_LIBTOOL_SYS_HARD_LINK_LOCKS' => 1,
+ 'AC_LIBTOOL_PROG_LD_SHLIBS' => 1,
+ '_LT_PROG_F77' => 1,
+ '_AM_MANGLE_OPTION' => 1,
'm4_pattern_forbid' => 1,
- '_LT_AC_TAGVAR' => 1,
- 'LT_PATH_NM' => 1,
- 'AC_LIBTOOL_SYS_OLD_ARCHIVE' => 1,
- 'AC_LTDL_SHLIBEXT' => 1,
- 'AC_ENABLE_FAST_INSTALL' => 1,
- '_LT_AC_PROG_ECHO_BACKSLASH' => 1,
- 'AM_PROG_NM' => 1,
- 'AM_CONDITIONAL' => 1,
- 'LT_FUNC_ARGZ' => 1,
- 'AC_LIBTOOL_LINKER_OPTION' => 1,
- 'LT_LANG' => 1,
- 'AC_LIBTOOL_DLOPEN_SELF' => 1,
- 'AC_DEPLIBS_CHECK_METHOD' => 1,
- 'AC_PATH_TOOL_PREFIX' => 1,
+ 'LT_PROG_GCJ' => 1,
+ 'PKG_CHECK_VAR' => 1,
+ 'AM_ENABLE_SHARED' => 1,
+ 'AM_PROG_CC_C_O' => 1,
+ 'AC_LIBTOOL_PROG_COMPILER_NO_RTTI' => 1,
+ 'AC_LTDL_SHLIBPATH' => 1,
+ '_LT_AC_SYS_COMPILER' => 1,
+ 'AC_LIBTOOL_FC' => 1,
+ 'AM_SET_DEPDIR' => 1,
+ 'LT_OUTPUT' => 1,
'AC_DISABLE_SHARED' => 1,
+ 'LT_SYS_DLOPEN_SELF' => 1,
+ 'AC_LIBTOOL_WIN32_DLL' => 1,
+ 'LT_SYS_MODULE_EXT' => 1,
+ '_AM_SET_OPTION' => 1,
+ 'LT_SYS_DLOPEN_DEPLIBS' => 1,
+ 'AM_CONDITIONAL' => 1,
+ 'AC_ENABLE_STATIC' => 1,
'_LT_PROG_LTMAIN' => 1,
- '_LT_COMPILER_BOILERPLATE' => 1,
- '_LT_PROG_ECHO_BACKSLASH' => 1,
- '_LT_AC_LANG_GCJ_CONFIG' => 1,
- '_m4_warn' => 1,
- '_LT_AC_TAGCONFIG' => 1,
- 'AC_LIBTOOL_SYS_GLOBAL_SYMBOL_PIPE' => 1,
- 'LT_AC_PROG_GCJ' => 1,
- 'LT_LIB_DLLOAD' => 1,
- '_LT_PROG_FC' => 1,
- 'AC_LIBTOOL_PROG_LD_SHLIBS' => 1,
+ 'AC_LIBTOOL_RC' => 1,
+ 'AC_LIBTOOL_DLOPEN' => 1,
+ '_LT_AC_LANG_C_CONFIG' => 1,
+ 'AC_LIBTOOL_PROG_COMPILER_PIC' => 1,
+ 'AC_LIBTOOL_GCJ' => 1,
+ 'LTDL_INIT' => 1,
+ '_LT_AC_LANG_F77_CONFIG' => 1,
+ 'AC_PROG_LD_RELOAD_FLAG' => 1,
+ 'AM_AUX_DIR_EXPAND' => 1,
+ 'LT_FUNC_DLSYM_USCORE' => 1,
+ 'AM_INIT_AUTOMAKE' => 1,
+ 'AC_LIBTOOL_LANG_RC_CONFIG' => 1,
+ '_LT_COMPILER_OPTION' => 1,
+ 'AM_PROG_LIBTOOL' => 1,
+ 'AM_SILENT_RULES' => 1,
'm4_include' => 1,
- 'LTOBSOLETE_VERSION' => 1,
+ 'PKG_CHECK_MODULES' => 1,
+ '_AM_SUBST_NOTMAKE' => 1,
+ 'LT_SYS_SYMBOL_USCORE' => 1,
+ 'AM_PROG_LD' => 1,
+ 'LT_WITH_LTDL' => 1,
+ '_LT_WITH_SYSROOT' => 1,
+ 'AC_LIBTOOL_POSTDEP_PREDEP' => 1,
+ 'AU_DEFUN' => 1,
+ 'LT_AC_PROG_RC' => 1,
+ 'PKG_PROG_PKG_CONFIG' => 1,
+ '_LT_AC_LANG_F77' => 1,
+ 'AM_PROG_INSTALL_SH' => 1,
+ '_AM_AUTOCONF_VERSION' => 1,
+ 'AC_LTDL_SYS_DLOPEN_DEPLIBS' => 1,
+ '_LT_DLL_DEF_P' => 1,
'LT_PROG_GO' => 1,
- 'AC_LIBTOOL_LANG_CXX_CONFIG' => 1,
- '_LT_AC_LANG_CXX' => 1,
- 'LT_AC_PROG_SED' => 1,
- 'AC_LIBTOOL_CONFIG' => 1,
+ 'AC_LTDL_SYMBOL_USCORE' => 1,
+ 'LT_CMD_MAX_LEN' => 1,
+ 'AM_SANITY_CHECK' => 1,
+ 'AM_DISABLE_STATIC' => 1,
+ '_LT_AC_FILE_LTDLL_C' => 1,
+ '_LT_PATH_TOOL_PREFIX' => 1,
+ '_LT_PROG_FC' => 1,
+ 'LT_SYS_DLSEARCH_PATH' => 1,
+ 'AC_LIBTOOL_PICMODE' => 1,
+ 'AC_CONFIG_MACRO_DIR' => 1,
+ 'AM_DEP_TRACK' => 1,
+ '_LT_AC_CHECK_DLFCN' => 1,
'_AM_DEPENDENCIES' => 1,
- '_LT_LINKER_BOILERPLATE' => 1,
- 'AC_LTDL_SYS_DLOPEN_DEPLIBS' => 1,
- 'AC_LIBTOOL_POSTDEP_PREDEP' => 1,
- 'AM_MISSING_HAS_RUN' => 1,
- 'AC_LTDL_SYSSEARCHPATH' => 1,
- '_AM_SET_OPTIONS' => 1,
+ 'AC_LIBTOOL_PROG_CC_C_O' => 1,
+ '_LT_AC_PROG_CXXCPP' => 1,
+ 'AM_AUTOMAKE_VERSION' => 1,
+ 'LT_AC_PROG_GCJ' => 1,
+ 'AC_DEFUN' => 1,
+ 'LT_SYS_MODULE_PATH' => 1,
+ 'AC_LTDL_DLLIB' => 1,
+ 'AM_PROG_NM' => 1,
+ 'LT_LANG' => 1,
'_AM_CONFIG_MACRO_DIRS' => 1,
- 'LT_SYS_DLOPEN_DEPLIBS' => 1,
- 'AM_SET_LEADING_DOT' => 1,
+ '_LT_AC_TAGVAR' => 1,
+ 'AC_LIBTOOL_DLOPEN_SELF' => 1,
'AC_LIBTOOL_LANG_F77_CONFIG' => 1,
+ '_LT_AC_PROG_ECHO_BACKSLASH' => 1,
'm4_pattern_allow' => 1,
- 'AM_MAKE_INCLUDE' => 1,
- '_LT_AC_LANG_F77_CONFIG' => 1,
- 'AC_LIBTOOL_FC' => 1,
- 'PKG_CHECK_EXISTS' => 1,
- 'AC_PROG_LIBTOOL' => 1,
'LT_INIT' => 1,
- 'PKG_CHECK_MODULES' => 1,
- 'AM_AUTOMAKE_VERSION' => 1,
- '_AM_IF_OPTION' => 1,
- 'include' => 1,
- 'AC_LIBLTDL_CONVENIENCE' => 1,
+ '_LT_PREPARE_SED_QUOTE_VARS' => 1,
+ 'AM_OUTPUT_DEPENDENCY_COMMANDS' => 1,
+ 'AM_SET_CURRENT_AUTOMAKE_VERSION' => 1,
+ 'LT_CONFIG_LTDL_DIR' => 1,
+ 'LT_SUPPORTED_TAG' => 1,
+ 'AC_WITH_LTDL' => 1,
+ 'AM_MISSING_HAS_RUN' => 1,
+ 'AC_LIBTOOL_SYS_LIB_STRIP' => 1,
+ '_AC_PROG_LIBTOOL' => 1,
'_LT_AC_LOCK' => 1,
- 'AC_CONFIG_MACRO_DIR' => 1,
- 'LT_SYS_MODULE_PATH' => 1,
- '_LT_PATH_TOOL_PREFIX' => 1,
- 'AM_PROG_LIBTOOL' => 1,
- 'LT_CMD_MAX_LEN' => 1,
- '_PKG_SHORT_ERRORS_SUPPORTED' => 1,
- '_LT_AC_SYS_LIBPATH_AIX' => 1,
- 'AC_LTDL_DLLIB' => 1,
- 'LT_SYS_DLSEARCH_PATH' => 1,
- 'AC_LTDL_SYMBOL_USCORE' => 1,
- 'AC_LIBTOOL_SYS_DYNAMIC_LINKER' => 1,
- 'AC_ENABLE_STATIC' => 1,
'_LT_PROG_CXX' => 1,
- 'AC_LIBTOOL_PROG_COMPILER_NO_RTTI' => 1,
- 'AC_PROG_LD' => 1,
- 'AC_LIBTOOL_SYS_HARD_LINK_LOCKS' => 1,
- 'AM_EXTRA_RECURSIVE_TARGETS' => 1,
- 'AC_LIBTOOL_PROG_CC_C_O' => 1,
- '_LT_AC_LANG_GCJ' => 1,
- '_LT_DLL_DEF_P' => 1,
- '_AC_PROG_LIBTOOL' => 1,
- 'AC_LIBTOOL_PROG_COMPILER_PIC' => 1,
- '_AM_PROG_CC_C_O' => 1,
- 'AM_ENABLE_STATIC' => 1,
- 'LTDL_CONVENIENCE' => 1,
- '_LT_COMPILER_OPTION' => 1,
- 'AC_CONFIG_MACRO_DIR_TRACE' => 1,
- '_AM_PROG_TAR' => 1,
- 'AM_PROG_LD' => 1,
- '_AM_MANGLE_OPTION' => 1,
- '_LT_AC_LANG_CXX_CONFIG' => 1,
- 'LT_PATH_LD' => 1,
- 'AC_LTDL_OBJDIR' => 1,
- 'AC_LTDL_PREOPEN' => 1,
- '_LT_LINKER_OPTION' => 1,
- 'AM_DEP_TRACK' => 1,
- 'LTDL_INIT' => 1,
- 'AC_LIBTOOL_LANG_C_CONFIG' => 1,
+ '_LTDL_SETUP' => 1,
+ 'AM_RUN_LOG' => 1,
+ 'LTOPTIONS_VERSION' => 1,
+ 'PKG_CHECK_MODULES_STATIC' => 1,
+ 'PKG_INSTALLDIR' => 1,
+ 'AC_PROG_NM' => 1,
+ '_LT_AC_LANG_GCJ_CONFIG' => 1,
+ 'AC_LIB_LTDL' => 1,
+ '_LT_AC_LANG_CXX' => 1,
'AC_DISABLE_FAST_INSTALL' => 1,
+ '_AM_OUTPUT_DEPENDENCY_COMMANDS' => 1,
+ 'LT_AC_PROG_EGREP' => 1,
+ 'AC_LTDL_ENABLE_INSTALL' => 1,
+ 'AC_LIBTOOL_CONFIG' => 1,
+ 'AC_DEPLIBS_CHECK_METHOD' => 1,
+ '_m4_warn' => 1,
'AC_LIBTOOL_CXX' => 1,
- 'AC_LIBTOOL_SYS_MAX_CMD_LEN' => 1,
- 'AC_LIBTOOL_LANG_RC_CONFIG' => 1,
- 'LT_AC_PROG_RC' => 1,
- 'AM_SUBST_NOTMAKE' => 1,
- '_LT_AC_SYS_COMPILER' => 1,
- 'LT_FUNC_DLSYM_USCORE' => 1,
- 'AM_MISSING_PROG' => 1,
- '_LT_WITH_SYSROOT' => 1,
- 'PKG_CHECK_VAR' => 1,
- 'AC_LIBTOOL_SETUP' => 1,
- '_AM_AUTOCONF_VERSION' => 1,
+ 'LTDL_CONVENIENCE' => 1,
+ 'AM_MAKE_INCLUDE' => 1,
+ 'AC_PATH_TOOL_PREFIX' => 1,
+ '_AM_PROG_CC_C_O' => 1,
+ 'PKG_CHECK_EXISTS' => 1,
+ 'AC_PROG_LD' => 1,
+ 'LT_AC_PROG_SED' => 1,
+ 'LTOBSOLETE_VERSION' => 1,
+ 'AC_LIBLTDL_INSTALLABLE' => 1,
+ '_LT_AC_SHELL_INIT' => 1,
+ '_LT_AC_SYS_LIBPATH_AIX' => 1,
'AC_CHECK_LIBM' => 1,
- 'AC_LIBTOOL_SYS_LIB_STRIP' => 1,
- 'LTVERSION_VERSION' => 1,
- 'LT_PROG_GCJ' => 1,
- 'AC_PROG_EGREP' => 1,
- 'AC_DEFUN_ONCE' => 1,
- 'AC_LIB_LTDL' => 1,
- 'PKG_PROG_PKG_CONFIG' => 1,
- 'AC_LIBTOOL_RC' => 1,
- '_LT_PROG_F77' => 1,
- 'AM_SANITY_CHECK' => 1,
+ 'AC_LIBTOOL_SETUP' => 1,
+ 'AC_DISABLE_STATIC' => 1,
+ 'AC_LIBTOOL_LANG_CXX_CONFIG' => 1,
'_LT_CC_BASENAME' => 1,
- 'AC_WITH_LTDL' => 1,
- 'AC_PATH_MAGIC' => 1,
- '_LT_AC_LANG_C_CONFIG' => 1,
- 'AM_SILENT_RULES' => 1,
- '_LT_AC_PROG_CXXCPP' => 1,
- 'AC_PROG_LD_GNU' => 1,
- '_LT_AC_SHELL_INIT' => 1
+ 'AC_LTDL_DLSYM_USCORE' => 1
}
], 'Autom4te::Request' ),
bless( [
'2',
1,
[
'/usr/share/autoconf'
],
[
'/usr/share/autoconf/autoconf/autoconf.m4f',
'aclocal.m4',
'configure.ac'
],
{
- 'AM_PROG_MOC' => 1,
+ 'AC_PROG_LIBTOOL' => 1,
+ '_AM_MAKEFILE_INCLUDE' => 1,
+ 'AC_CONFIG_FILES' => 1,
+ 'AC_CONFIG_HEADERS' => 1,
'IT_PROG_INTLTOOL' => 1,
- 'AM_PROG_AR' => 1,
- 'm4_pattern_allow' => 1,
- 'AC_CONFIG_AUX_DIR' => 1,
'sinclude' => 1,
- 'AM_NLS' => 1,
- 'GTK_DOC_CHECK' => 1,
- '_AM_SUBST_NOTMAKE' => 1,
- 'AC_CONFIG_FILES' => 1,
- 'AC_CANONICAL_TARGET' => 1,
- 'LT_INIT' => 1,
- 'AM_PROG_MKDIR_P' => 1,
- 'AC_FC_FREEFORM' => 1,
- 'LT_SUPPORTED_TAG' => 1,
- 'AC_PROG_LIBTOOL' => 1,
- 'AM_MAKEFILE_INCLUDE' => 1,
- 'AM_AUTOMAKE_VERSION' => 1,
+ 'AC_CANONICAL_SYSTEM' => 1,
'AC_FC_SRCEXT' => 1,
- 'm4_pattern_forbid' => 1,
- 'AM_GNU_GETTEXT_INTL_SUBDIR' => 1,
- 'AC_CONFIG_LINKS' => 1,
- 'AM_PROG_CXX_C_O' => 1,
- 'AM_POT_TOOLS' => 1,
- 'AC_SUBST_TRACE' => 1,
- 'include' => 1,
- 'AC_CANONICAL_HOST' => 1,
- 'AM_INIT_AUTOMAKE' => 1,
+ 'AM_XGETTEXT_OPTION' => 1,
+ '_AM_COND_ELSE' => 1,
+ '_m4_warn' => 1,
'AM_CONDITIONAL' => 1,
+ 'AM_PROG_AR' => 1,
'AC_CONFIG_LIBOBJ_DIR' => 1,
- 'AM_PROG_F77_C_O' => 1,
- 'AM_PROG_CC_C_O' => 1,
- 'AC_CONFIG_HEADERS' => 1,
- 'AM_ENABLE_MULTILIB' => 1,
- '_AM_COND_ENDIF' => 1,
- 'AH_OUTPUT' => 1,
- 'AC_DEFINE_TRACE_LITERAL' => 1,
- '_AM_COND_IF' => 1,
- 'AM_PROG_LIBTOOL' => 1,
- 'AC_INIT' => 1,
- 'AM_PATH_GUILE' => 1,
- '_m4_warn' => 1,
- 'AC_SUBST' => 1,
+ 'AM_MAKEFILE_INCLUDE' => 1,
'LT_CONFIG_LTDL_DIR' => 1,
- 'AC_CANONICAL_BUILD' => 1,
- 'AC_REQUIRE_AUX_FILE' => 1,
+ 'm4_pattern_forbid' => 1,
+ 'AM_MAINTAINER_MODE' => 1,
+ 'LT_INIT' => 1,
+ 'm4_pattern_allow' => 1,
'_LT_AC_TAGCONFIG' => 1,
- 'AM_EXTRA_RECURSIVE_TARGETS' => 1,
+ 'LT_SUPPORTED_TAG' => 1,
'AC_FC_PP_DEFINE' => 1,
- 'm4_sinclude' => 1,
- 'AM_GNU_GETTEXT' => 1,
- '_AM_MAKEFILE_INCLUDE' => 1,
- 'm4_include' => 1,
+ 'AC_CANONICAL_BUILD' => 1,
+ '_AM_SUBST_NOTMAKE' => 1,
'AC_LIBSOURCE' => 1,
- 'AC_CANONICAL_SYSTEM' => 1,
- 'AC_CONFIG_MACRO_DIR_TRACE' => 1,
+ 'AC_REQUIRE_AUX_FILE' => 1,
+ 'AC_CONFIG_LINKS' => 1,
+ 'AC_SUBST' => 1,
+ 'AC_FC_FREEFORM' => 1,
'AM_PROG_FC_C_O' => 1,
- 'AM_SILENT_RULES' => 1,
- 'AM_XGETTEXT_OPTION' => 1,
+ 'AC_INIT' => 1,
+ 'GTK_DOC_CHECK' => 1,
+ 'AM_PATH_GUILE' => 1,
+ 'm4_sinclude' => 1,
+ 'AM_PROG_CC_C_O' => 1,
+ 'AM_PROG_MKDIR_P' => 1,
+ 'AC_DEFINE_TRACE_LITERAL' => 1,
+ 'AC_SUBST_TRACE' => 1,
'AC_FC_PP_SRCEXT' => 1,
- 'AM_MAINTAINER_MODE' => 1,
- '_AM_COND_ELSE' => 1,
- 'AC_CONFIG_SUBDIRS' => 1
+ 'AM_NLS' => 1,
+ 'AM_AUTOMAKE_VERSION' => 1,
+ '_AM_COND_IF' => 1,
+ 'm4_include' => 1,
+ 'AM_SILENT_RULES' => 1,
+ 'AM_GNU_GETTEXT' => 1,
+ 'AM_INIT_AUTOMAKE' => 1,
+ 'AC_CONFIG_MACRO_DIR_TRACE' => 1,
+ 'AM_PROG_LIBTOOL' => 1,
+ 'AM_ENABLE_MULTILIB' => 1,
+ 'AM_PROG_F77_C_O' => 1,
+ 'AC_CONFIG_AUX_DIR' => 1,
+ 'include' => 1,
+ '_AM_COND_ENDIF' => 1,
+ 'AC_CANONICAL_TARGET' => 1,
+ 'AC_CONFIG_SUBDIRS' => 1,
+ 'AM_EXTRA_RECURSIVE_TARGETS' => 1,
+ 'AM_PROG_MOC' => 1,
+ 'AH_OUTPUT' => 1,
+ 'AM_PROG_CXX_C_O' => 1,
+ 'AM_POT_TOOLS' => 1,
+ 'AM_GNU_GETTEXT_INTL_SUBDIR' => 1,
+ 'AC_CANONICAL_HOST' => 1
}
], 'Autom4te::Request' ),
bless( [
'3',
1,
[
'/usr/share/autoconf'
],
[
'/usr/share/autoconf/autoconf/autoconf.m4f',
'aclocal.m4',
'/usr/share/autoconf/autoconf/trailer.m4',
'configure.ac'
],
{
- 'AC_FC_PP_SRCEXT' => 1,
- 'AM_XGETTEXT_OPTION' => 1,
+ 'sinclude' => 1,
+ 'IT_PROG_INTLTOOL' => 1,
+ 'AC_CONFIG_FILES' => 1,
+ 'AC_CONFIG_HEADERS' => 1,
+ 'AC_PROG_LIBTOOL' => 1,
+ '_AM_MAKEFILE_INCLUDE' => 1,
+ 'AM_PROG_AR' => 1,
+ 'AC_CONFIG_LIBOBJ_DIR' => 1,
+ 'AM_MAKEFILE_INCLUDE' => 1,
+ 'AM_CONDITIONAL' => 1,
'_AM_COND_ELSE' => 1,
- 'AC_CONFIG_SUBDIRS' => 1,
- 'AM_MAINTAINER_MODE' => 1,
+ '_m4_warn' => 1,
+ 'AC_FC_SRCEXT' => 1,
'AC_CANONICAL_SYSTEM' => 1,
- 'AC_CONFIG_MACRO_DIR_TRACE' => 1,
- 'AM_PROG_FC_C_O' => 1,
- 'AM_SILENT_RULES' => 1,
- 'AM_EXTRA_RECURSIVE_TARGETS' => 1,
- 'AC_FC_PP_DEFINE' => 1,
- '_AM_MAKEFILE_INCLUDE' => 1,
- 'm4_include' => 1,
+ 'AM_XGETTEXT_OPTION' => 1,
'AC_LIBSOURCE' => 1,
- 'm4_sinclude' => 1,
- 'AM_GNU_GETTEXT' => 1,
- 'AC_SUBST' => 1,
- 'LT_CONFIG_LTDL_DIR' => 1,
+ 'AC_REQUIRE_AUX_FILE' => 1,
+ 'AC_FC_PP_DEFINE' => 1,
'AC_CANONICAL_BUILD' => 1,
- 'AC_INIT' => 1,
- 'AM_PATH_GUILE' => 1,
- '_m4_warn' => 1,
+ '_AM_SUBST_NOTMAKE' => 1,
'_LT_AC_TAGCONFIG' => 1,
- 'AC_REQUIRE_AUX_FILE' => 1,
- 'AC_CONFIG_LIBOBJ_DIR' => 1,
- 'AM_PROG_F77_C_O' => 1,
- 'AM_ENABLE_MULTILIB' => 1,
+ 'LT_SUPPORTED_TAG' => 1,
+ 'LT_CONFIG_LTDL_DIR' => 1,
+ 'm4_pattern_forbid' => 1,
+ 'LT_INIT' => 1,
+ 'AM_MAINTAINER_MODE' => 1,
+ 'm4_pattern_allow' => 1,
+ 'm4_sinclude' => 1,
'AM_PROG_CC_C_O' => 1,
- 'AC_CONFIG_HEADERS' => 1,
- 'AM_CONDITIONAL' => 1,
- 'AM_INIT_AUTOMAKE' => 1,
- 'AC_CANONICAL_HOST' => 1,
- 'AM_PROG_LIBTOOL' => 1,
- '_AM_COND_ENDIF' => 1,
- 'AH_OUTPUT' => 1,
- '_AM_COND_IF' => 1,
- 'AC_DEFINE_TRACE_LITERAL' => 1,
- 'AM_GNU_GETTEXT_INTL_SUBDIR' => 1,
+ 'AM_PROG_MKDIR_P' => 1,
+ 'AC_INIT' => 1,
+ 'GTK_DOC_CHECK' => 1,
+ 'AM_PATH_GUILE' => 1,
+ 'AC_FC_FREEFORM' => 1,
+ 'AM_PROG_FC_C_O' => 1,
'AC_CONFIG_LINKS' => 1,
+ 'AC_SUBST' => 1,
+ 'AM_NLS' => 1,
+ '_AM_COND_IF' => 1,
'AM_AUTOMAKE_VERSION' => 1,
- 'AC_FC_SRCEXT' => 1,
- 'm4_pattern_forbid' => 1,
'AC_SUBST_TRACE' => 1,
+ 'AC_FC_PP_SRCEXT' => 1,
+ 'AC_DEFINE_TRACE_LITERAL' => 1,
+ 'AC_CONFIG_MACRO_DIR_TRACE' => 1,
+ 'AM_PROG_LIBTOOL' => 1,
+ 'AM_ENABLE_MULTILIB' => 1,
+ 'AM_INIT_AUTOMAKE' => 1,
+ 'AM_GNU_GETTEXT' => 1,
+ 'm4_include' => 1,
+ 'AM_SILENT_RULES' => 1,
'include' => 1,
- 'AM_PROG_CXX_C_O' => 1,
- 'AM_POT_TOOLS' => 1,
- 'GTK_DOC_CHECK' => 1,
- 'AM_NLS' => 1,
- '_AM_SUBST_NOTMAKE' => 1,
- 'AC_CONFIG_FILES' => 1,
- 'sinclude' => 1,
- 'AC_CONFIG_AUX_DIR' => 1,
- 'AC_FC_FREEFORM' => 1,
- 'AM_PROG_MKDIR_P' => 1,
- 'LT_SUPPORTED_TAG' => 1,
- 'AC_PROG_LIBTOOL' => 1,
- 'AM_MAKEFILE_INCLUDE' => 1,
'AC_CANONICAL_TARGET' => 1,
- 'LT_INIT' => 1,
+ '_AM_COND_ENDIF' => 1,
+ 'AC_CONFIG_AUX_DIR' => 1,
+ 'AM_PROG_F77_C_O' => 1,
+ 'AC_CANONICAL_HOST' => 1,
'AM_PROG_MOC' => 1,
- 'IT_PROG_INTLTOOL' => 1,
- 'm4_pattern_allow' => 1,
- 'AM_PROG_AR' => 1
+ 'AH_OUTPUT' => 1,
+ 'AM_PROG_CXX_C_O' => 1,
+ 'AM_POT_TOOLS' => 1,
+ 'AM_GNU_GETTEXT_INTL_SUBDIR' => 1,
+ 'AC_CONFIG_SUBDIRS' => 1,
+ 'AM_EXTRA_RECURSIVE_TARGETS' => 1
}
], 'Autom4te::Request' )
);

File Metadata

Mime Type
text/x-diff
Expires
Sat, Dec 21, 2:23 PM (8 h, 56 m)
Storage Engine
blob
Storage Format
Raw Data
Storage Handle
4023102
Default Alt Text
(284 KB)

Event Timeline