Index: trunk/npstat/stat/UnbinnedGOFTests1D.icc =================================================================== --- trunk/npstat/stat/UnbinnedGOFTests1D.icc (revision 739) +++ trunk/npstat/stat/UnbinnedGOFTests1D.icc (revision 740) @@ -1,36 +1,62 @@ #include #include #include #include #include +#include +#include + +#define npstat_UnbinnedGOFTests1D_get_data_sorted /**/ \ + assert(data); \ + const Numeric* sorted = data; \ + std::unique_ptr > sortedPtr; \ + if (!dataIsSorted) \ + { \ + sortedPtr = std::unique_ptr >( \ + new std::vector(data, data + lenData)); \ + std::sort(sortedPtr->begin(), sortedPtr->end()); \ + sorted = &(*sortedPtr)[0]; \ + } namespace npstat { template double KSTest1D::testStat(const Numeric* data, const unsigned long lenData, const bool dataIsSorted) const { if (!lenData) throw std::invalid_argument( "In npstat::KSTest1D::testStat: no data provided"); - assert(data); - - const Numeric* sorted = data; - std::unique_ptr > sortedPtr; - if (!dataIsSorted) - { - sortedPtr = std::unique_ptr >( - new std::vector(data, data + lenData)); - std::sort(sortedPtr->begin(), sortedPtr->end()); - sorted = &(*sortedPtr)[0]; - } + npstat_UnbinnedGOFTests1D_get_data_sorted; + double maxDist = -1.0; const double n = static_cast(lenData); for (unsigned long i = 0; icdf(sorted[i]); maxDist = std::max(maxDist, std::abs(i/n - cdf)); maxDist = std::max(maxDist, std::abs((i + 1UL)/n - cdf)); } return maxDist; } + + template + double ADTest1D::testStat(const Numeric* data, const unsigned long lenData, + const bool dataIsSorted) const + { + if (!lenData) throw std::invalid_argument( + "In npstat::ADTest1D::testStat: no data provided"); + + npstat_UnbinnedGOFTests1D_get_data_sorted; + + long double sum = 0.0L; + for (unsigned long i = 0; icdf(sorted[i]); + const long double cdf2 = distro_->cdf(sorted[lenData - 1UL - i]); + if (cdf1 == 0.0L || cdf1 == 1.0L || cdf2 == 0.0L || cdf2 == 1.0L) + return DBL_MAX; + sum += (2UL*i + 1)*logl(cdf1*(1.0L - cdf2)); + } + return -sum/lenData - static_cast(lenData); + } } Index: trunk/npstat/stat/StatUtils.cc =================================================================== --- trunk/npstat/stat/StatUtils.cc (revision 0) +++ trunk/npstat/stat/StatUtils.cc (revision 740) @@ -0,0 +1,89 @@ +#include + +#include "npstat/stat/StatUtils.hh" + +static double ADf(const double z, const int j) +{ + const double t = (4*j+1)*(4*j+1)*1.23370055013617/z; + if (t > 150.0) + return 0.0; + double a = 2.22144146907918*exp(-t)/sqrt(t); + // double b = 3.93740248643060*2.*cPhi(sqrt(2*t)); /* requires cPhi */ + /*if you have erfc(), replace 2*cPhi(sqrt(2*t)) with erfc(sqrt(t))*/ + double b = 3.93740248643060*erfc(sqrt(t)); + double r = z*.125; + double f = a+b*r; + for (int i=1; i<200; i++) + { + const double c = ((i-.5-t)*b+t*a)/i; + a=b; b=c; + r *= z/(8*i+8); + if (fabs(r) < 1.e-40 || fabs(c) < 1.e-40) + return f; + const double fnew = f+c*r; + if (f == fnew) + return f; + f = fnew; + } + return f; +} + +static double ADinf(const double z) +{ + if (z < 0.01) + return 0.0; /* avoids exponent limits; ADinf(.01)=.528e-52 */ + if (z > 32.0) + return 1.0; + + double r = 1.0/z; + double ad = r*ADf(z, 0); + for (int j=1; j<100; j++) + { + r *= (0.5 - j)/j; + const double adnew = ad+(4*j+1)*r*ADf(z,j); + if (ad == adnew) + return ad; + ad = adnew; + } + return ad; +} + +namespace npstat { + double aicc(const double k, const double logli, const double n) + { + const double aic = 2.0*k - 2.0*logli; + const double denom = n - k - 1; + if (denom > 0.0) + return aic + 2.0*k*(k + 1.0)/denom; + else if (k > 0.0) + return DBL_MAX; + else + return aic; + } + + double AD(const double n, const double z) + { + const double x = ADinf(z); + + /* now x=adinf(z). Next, get v=errfix(n,x) and return x+v; */ + if (x > 0.8) + { + const double v=(-130.2137+(745.2337-(1705.091-(1950.646-(1116.360-255.7844*x)*x)*x)*x)*x)/n; + return x+v; + } + + const double c=.01265+.1757/n; + if (x < c) + { + double v = x/c; + v=sqrt(v)*(1.-v)*(49*v-102); + return x+v*(.0037/n/n + .00078/n + .00006)/n; + } + else + { + double v = (x-c)/(.8-c); + v=-.00022633+(6.54034-(14.6538-(14.458-(8.259-1.91864*v)*v)*v)*v)*v; + return x+v*(.04213+.01365/n)/n; + } + } +} Index: trunk/npstat/stat/StatUtils.icc =================================================================== --- trunk/npstat/stat/StatUtils.icc (revision 739) +++ trunk/npstat/stat/StatUtils.icc (revision 740) @@ -1,239 +1,227 @@ #include #include #include #include #include namespace npstat { template Data empiricalQuantile(const std::vector& data, const double x, const bool increaseRange) { if (!(x >= 0.0 && x <= 1.0)) throw std::domain_error( "In npstat::empiricalQuantile: cdf argument " "outside of [0, 1] interval"); const std::size_t sz = data.size(); if (!sz) throw std::invalid_argument( "In npstat::empiricalQuantile: no data provided"); if ((x == 0.0 || x == 1.0) && increaseRange) { if (sz == 1U) { // There is no natural scale factor. // We need to invent something Data one = static_cast(1); if (x == 0.0) { Data dm1 = data[0] - one; if (dm1 != data[0]) return dm1; else return data[0] - std::abs(data[0])*0.01; } else { Data dp1 = data[0] + one; if (dp1 != data[0]) return dp1; else return data[0] + std::abs(data[0])*0.01; } } else { Data scale = (data[sz - 1] - data[0])*(1.0/sz); if (scale == Data()) scale = static_cast(1); if (x == 0.0) return data[0] - scale*0.1; else return data[sz - 1] + scale*0.1; } } if (sz == 1U) return data[0]; const double find = x*sz - 0.5; if (find <= 0.0) return data[0]; const std::size_t ibelow = static_cast(floor(find)); const std::size_t iabove = ibelow + 1; if (iabove >= sz) return data[sz - 1]; else return data[ibelow] + (data[iabove]-data[ibelow])*(find-ibelow); } template double empiricalCdf(const std::vector& data, const Data& x) { const std::size_t sz = data.size(); if (!sz) throw std::invalid_argument( "In npstat::empiricalCdf: no data provided"); if (sz == 1U) { if (x < data[0]) return 0.0; else if (data[0] < x) return 1.0; else return 0.5; } const std::size_t iabove = lower_bound(data.begin(), data.end(), x) - data.begin(); if (iabove == 0) return 0.0; else if (iabove == sz) return 1.0; else if (iabove == sz - 1 && x == data[sz - 1]) return 1.0; else { const std::size_t ibelow = iabove - 1; double cdf = ((x-data[ibelow])*1.0/(data[iabove]-data[ibelow]) +ibelow+0.5)/sz; if (cdf < 0.5/sz) cdf = 0.5/sz; if (cdf > (sz - 0.5)/sz) cdf = (sz - 0.5)/sz; return cdf; } } template unsigned long quantileBinFromCdf( const Data* cdf, const unsigned long arrLen, const Data q, Data* remainder) { if (!(arrLen > 1UL)) throw std::invalid_argument( "In npstat::quantileBinFromCdf: insufficient amount of data"); assert(cdf); if (remainder) *remainder = static_cast(0.0); if (q <= cdf[0]) { unsigned long i = 1UL; for (; cdf[i] == cdf[0] && i < arrLen; ++i); return i - 1; } if (q >= cdf[arrLen - 1UL]) { unsigned long i = arrLen - 1UL; for (; cdf[i-1UL] == cdf[arrLen-1UL] && i>0; --i); return i; } unsigned long imin = 0, imax = arrLen - 1UL; while (imax - imin > 1UL) { const unsigned long i = (imax + imin)/2UL; if (cdf[i] > q) imax = i; else if (cdf[i] < q) imin = i; else { for (imax = i; cdf[imax+1] == cdf[i]; ++imax); for (imin = i; cdf[imin-1] == cdf[i]; --imin); return (imin + imax)/2UL; } } if (remainder && cdf[imax] > cdf[imin]) *remainder = (q - cdf[imin])/(cdf[imax] - cdf[imin]); return imin; } template Real squaredDerivativeIntegral(Real* fvalues, const unsigned long arrLen, const unsigned deri, const Real h) { if (arrLen < 2UL || arrLen <= deri) throw std::invalid_argument( "In npstat::squaredDerivativeIntegral: " "insufficient amount of data"); assert(fvalues); if (!(h > static_cast(0))) throw std::invalid_argument( "In npstat::squaredDerivativeIntegral: " "step size must be positive"); // Calculate the derivative long double hprod = h; unsigned long kmax = arrLen - 1; for (unsigned i=0; i(sum*hprod); } template inline bool normalizeArrayAsDensity(Real* arr, const unsigned long n, const double binwidth, double* pnorm) { bool hasNegatives = false; if (n) { const Real zero = Real(); assert(arr); long double integ = 0.0L; for (unsigned long i=0; i(1.0L/integ/binwidth); } else { if (pnorm) *pnorm = 1.0; } return hasNegatives; } - - inline double aicc(const double k, const double logli, const double n) - { - const double aic = 2.0*k - 2.0*logli; - const double denom = n - k - 1; - if (denom > 0.0) - return aic + 2.0*k*(k + 1.0)/denom; - else if (k > 0.0) - return DBL_MAX; - else - return aic; - } } Index: trunk/npstat/stat/UnbinnedGOFTests1D.cc =================================================================== --- trunk/npstat/stat/UnbinnedGOFTests1D.cc (revision 739) +++ trunk/npstat/stat/UnbinnedGOFTests1D.cc (revision 740) @@ -1,15 +1,21 @@ #include #include "kstest/kstest.hh" #include "npstat/stat/UnbinnedGOFTests1D.hh" -#include "npstat/stat/UnbinnedGOFTests1D.hh" +#include "npstat/stat/StatUtils.hh" namespace npstat { double KSTest1D::analyticPValue(const double stat, const unsigned long sz) const { assert(sz <= UINT_MAX); return kstest::KSfbar(sz, stat); } + + double ADTest1D::analyticPValue(const double stat, + const unsigned long sz) const + { + return 1.0 - AD(sz, stat); + } } Index: trunk/npstat/stat/Makefile.in =================================================================== --- trunk/npstat/stat/Makefile.in (revision 739) +++ trunk/npstat/stat/Makefile.in (revision 740) @@ -1,1255 +1,1256 @@ # Makefile.in generated by automake 1.15.1 from Makefile.am. # @configure_input@ # Copyright (C) 1994-2017 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 AbsCopulaSmootherBase.lo \ - BernsteinCopulaSmoother.lo distro1DStats.lo \ - SequentialGroupedCopulaSmoother.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 PolynomialDistro1D.lo \ AbsUnbinnedGOFTest1D.lo OrthoPolyGOFTest1D.lo \ UnbinnedGOFTests1D.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__depfiles_maybe = depfiles 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)` ETAGS = etags CTAGS = ctags 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@ CPP = @CPP@ CPPFLAGS = @CPPFLAGS@ 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@ 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 \ + 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 \ PolynomialDistro1D.cc AbsUnbinnedGOFTest1D.cc OrthoPolyGOFTest1D.cc \ UnbinnedGOFTests1D.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 \ AbsSymbetaFilterProvider.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 \ BoundaryHandling.hh \ BoundaryMethod.hh \ buildInterpolatedCompositeDistroND.hh \ buildInterpolatedCompositeDistroND.icc \ buildInterpolatedDistro1DNP.hh \ buildInterpolatedDistro1DNP.icc \ buildInterpolatedHelpers.hh \ CensoredQuantileRegression.hh \ CensoredQuantileRegression.icc \ 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 \ 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 \ empiricalCopula.hh \ empiricalCopulaHisto.hh \ empiricalCopulaHisto.icc \ empiricalCopula.icc \ ExpTiltedDistribution1D.hh \ fillHistoFromText.hh \ fillHistoFromText.icc \ Filter1DBuilders.hh \ FitUtils.hh \ FitUtils.icc \ GaussianMixtureEntry.hh \ GaussianMixture1D.hh \ gaussianResponseMatrix.hh \ GCVCopulaSmoother.hh \ GCVCopulaSmoother.icc \ 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 \ JohnsonKDESmoother.hh \ KDE1D.hh \ KDE1DCV.hh \ KDE1DHOSymbetaKernel.hh \ KDECopulaSmoother.hh \ KDECopulaSmoother.icc \ KDEGroupedCopulaSmoother.hh \ KDEGroupedCopulaSmoother.icc \ KDEFilterND.hh \ KDEFilterND.icc \ kendallsTau.hh \ kendallsTau.icc \ kernelSensitivityMatrix.hh \ kernelSensitivityMatrix.icc \ LeftCensoredDistribution.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 \ logLikelihoodPeak.hh \ LogRatioTransform1D.hh \ LogTransform1D.hh \ LOrPECopulaSmoother.hh \ LOrPECopulaSmoother.icc \ LOrPEGroupedCopulaSmoother.hh \ LOrPEGroupedCopulaSmoother.icc \ LOrPEMarginalSmoother.hh \ lorpeBackgroundCVDensity1D.hh \ lorpeBackgroundCVDensity1D.icc \ lorpeBackground1D.hh \ lorpeBackground1D.icc \ lorpeMise1D.hh \ lorpeSmooth1D.hh \ lorpeSmooth1D.icc \ MatrixFilter1DBuilder.hh \ MemoizingSymbetaFilterProvider.hh \ mergeTwoHistos.hh \ mergeTwoHistos.icc \ mirrorWeight.hh \ MultiscaleEMUnfold1D.hh \ multinomialCovariance1D.hh \ MultivariateSumAccumulator.hh \ MultivariateSumsqAccumulator.hh \ MultivariateSumsqAccumulator.icc \ MultivariateWeightedSumAccumulator.hh \ MultivariateWeightedSumsqAccumulator.hh \ MultivariateWeightedSumsqAccumulator.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 \ NUHistoAxis.hh \ OrderedPointND.hh \ OrderedPointND.icc \ orthoPoly1DVProducts.hh \ orthoPoly1DVProducts.icc \ OrthoPolyGOFTest1D.hh \ OrthoPolyGOFTest1D.icc \ OSDE1D.hh \ OSDE1D.icc \ PearsonsChiSquared.hh \ PolyFilterCollection1D.hh \ PolynomialDistro1D.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 \ RatioOfNormals.hh \ RatioResponseBoxBuilder.hh \ RatioResponseBoxBuilder.icc \ RatioResponseIntervalBuilder.hh \ RatioResponseIntervalBuilder.icc \ ResponseMatrix.hh \ RightCensoredDistribution.hh \ saddlepointDistribution1D.hh \ SampleAccumulator.hh \ SampleAccumulator.icc \ SbMomentsCalculator.hh \ ScalableGaussND.hh \ scannedKSDistance.hh \ scanMultivariateDensityAsWeight.hh \ scanSymmetricDensityAsWeight.hh \ SequentialCopulaSmoother.hh \ SequentialCopulaSmoother.icc \ SequentialGroupedCopulaSmoother.hh \ SequentialGroupedCopulaSmoother.icc \ SequentialPolyFilterND.hh \ SequentialPolyFilterND.icc \ SeriesCGF1D.hh \ SinhAsinhTransform1D.hh \ SmoothedEMUnfold1D.hh \ SmoothedEMUnfoldND.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 \ TwoPointsLTSLoss.hh \ TwoPointsLTSLoss.icc \ UGaussConvolution1D.hh \ UnbinnedGOFTests1D.hh \ UnbinnedGOFTests1D.icc \ 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__depfiles_maybe)'; \ cd $(top_builddir) && $(SHELL) ./config.status $(subdir)/$@ $(am__depfiles_maybe);; \ 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@ @AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/AbsCGF1D.Plo@am__quote@ @AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/AbsCVCopulaSmoother.Plo@am__quote@ @AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/AbsCopulaSmootherBase.Plo@am__quote@ @AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/AbsDiscreteDistribution1D.Plo@am__quote@ @AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/AbsDistribution1D.Plo@am__quote@ @AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/AbsDistributionND.Plo@am__quote@ @AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/AbsDistributionTransform1D.Plo@am__quote@ @AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/AbsFilter1DBuilder.Plo@am__quote@ @AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/AbsKDE1DKernel.Plo@am__quote@ @AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/AbsMarginalSmootherBase.Plo@am__quote@ @AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/AbsNtuple.Plo@am__quote@ @AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/AbsUnbinnedGOFTest1D.Plo@am__quote@ @AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/AbsUnfold1D.Plo@am__quote@ @AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/AbsUnfoldND.Plo@am__quote@ @AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/AbsUnfoldingFilterND.Plo@am__quote@ @AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/AllSymbetaParams1D.Plo@am__quote@ @AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/AsinhTransform1D.Plo@am__quote@ @AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/BernsteinCopulaSmoother.Plo@am__quote@ @AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/BernsteinFilter1DBuilder.Plo@am__quote@ @AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/BetaFilter1DBuilder.Plo@am__quote@ @AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/BinSummary.Plo@am__quote@ @AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/BinnedADTest1D.Plo@am__quote@ @AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/BinnedKSTest1D.Plo@am__quote@ @AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/BoundaryHandling.Plo@am__quote@ @AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/ComparisonDistribution1D.Plo@am__quote@ @AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/CompositeDistribution1D.Plo@am__quote@ @AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/CompositeDistributionND.Plo@am__quote@ @AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/ConstantBandwidthSmoother1D.Plo@am__quote@ @AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/CopulaInterpolationND.Plo@am__quote@ @AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/Copulas.Plo@am__quote@ @AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/CrossCovarianceAccumulator.Plo@am__quote@ @AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/DeltaMixture1D.Plo@am__quote@ @AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/DensityOrthoPoly1D.Plo@am__quote@ @AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/DensityScan1D.Plo@am__quote@ @AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/DiscreteDistribution1DReader.Plo@am__quote@ @AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/DiscreteDistributions1D.Plo@am__quote@ @AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/DiscreteGauss1DBuilder.Plo@am__quote@ @AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/DiscreteGaussCopulaSmoother.Plo@am__quote@ @AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/Distribution1DFactory.Plo@am__quote@ @AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/Distribution1DReader.Plo@am__quote@ @AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/DistributionMix1D.Plo@am__quote@ @AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/DistributionMixND.Plo@am__quote@ @AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/DistributionNDReader.Plo@am__quote@ @AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/DistributionTransform1DReader.Plo@am__quote@ @AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/Distributions1D.Plo@am__quote@ @AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/DistributionsND.Plo@am__quote@ @AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/DualHistoAxis.Plo@am__quote@ @AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/EdgeworthSeries1D.Plo@am__quote@ @AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/EdgeworthSeriesMethod.Plo@am__quote@ @AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/ExpTiltedDistribution1D.Plo@am__quote@ @AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/Filter1DBuilders.Plo@am__quote@ @AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/GaussianMixture1D.Plo@am__quote@ @AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/GaussianMixtureEntry.Plo@am__quote@ @AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/GridInterpolatedDistribution.Plo@am__quote@ @AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/GridRandomizer.Plo@am__quote@ @AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/HistoAxis.Plo@am__quote@ @AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/HistoNDCdf.Plo@am__quote@ @AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/IdentityTransform1D.Plo@am__quote@ @AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/InterpolatedDistribution1D.Plo@am__quote@ @AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/InterpolatedDistro1D1P.Plo@am__quote@ @AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/InterpolatedDistro1DNP.Plo@am__quote@ @AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/JohnsonCurves.Plo@am__quote@ @AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/JohnsonKDESmoother.Plo@am__quote@ @AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/KDE1DHOSymbetaKernel.Plo@am__quote@ @AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/LOrPEMarginalSmoother.Plo@am__quote@ @AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/LeftCensoredDistribution.Plo@am__quote@ @AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/LikelihoodStatisticType.Plo@am__quote@ @AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/LocalMultiFilter1D.Plo@am__quote@ @AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/LocalPolyFilter1D.Plo@am__quote@ @AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/LocalPolyFilter1DReader.Plo@am__quote@ @AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/LocationScaleFamily1D.Plo@am__quote@ @AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/LogRatioTransform1D.Plo@am__quote@ @AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/LogTransform1D.Plo@am__quote@ @AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/MatrixFilter1DBuilder.Plo@am__quote@ @AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/MemoizingSymbetaFilterProvider.Plo@am__quote@ @AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/MultiscaleEMUnfold1D.Plo@am__quote@ @AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/NMCombinationSequencer.Plo@am__quote@ @AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/NUHistoAxis.Plo@am__quote@ @AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/OSDE1D.Plo@am__quote@ @AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/OrthoPolyGOFTest1D.Plo@am__quote@ @AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/PearsonsChiSquared.Plo@am__quote@ @AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/PolyFilterCollection1D.Plo@am__quote@ @AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/PolynomialDistro1D.Plo@am__quote@ @AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/ProductSymmetricBetaNDCdf.Plo@am__quote@ @AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/QuadraticOrthoPolyND.Plo@am__quote@ @AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/QuantileTable1D.Plo@am__quote@ @AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/RatioOfNormals.Plo@am__quote@ @AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/ResponseMatrix.Plo@am__quote@ @AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/RightCensoredDistribution.Plo@am__quote@ @AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/SbMomentsBigGamma.Plo@am__quote@ @AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/SbMomentsCalculator.Plo@am__quote@ @AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/ScalableGaussND.Plo@am__quote@ @AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/SequentialCopulaSmoother.Plo@am__quote@ @AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/SequentialGroupedCopulaSmoother.Plo@am__quote@ @AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/SequentialPolyFilterND.Plo@am__quote@ @AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/SeriesCGF1D.Plo@am__quote@ @AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/SinhAsinhTransform1D.Plo@am__quote@ @AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/SmoothedEMUnfold1D.Plo@am__quote@ @AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/SmoothedEMUnfoldND.Plo@am__quote@ @AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/StatAccumulator.Plo@am__quote@ @AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/StatAccumulatorArr.Plo@am__quote@ @AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/StatAccumulatorPair.Plo@am__quote@ +@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/StatUtils.Plo@am__quote@ @AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/StorableMultivariateFunctor.Plo@am__quote@ @AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/StorableMultivariateFunctorReader.Plo@am__quote@ @AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/SymbetaParams1D.Plo@am__quote@ @AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/TransformedDistribution1D.Plo@am__quote@ @AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/TruncatedDistribution1D.Plo@am__quote@ @AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/UGaussConvolution1D.Plo@am__quote@ @AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/UnbinnedGOFTests1D.Plo@am__quote@ @AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/UnfoldingBandwidthScanner1D.Plo@am__quote@ @AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/UnfoldingBandwidthScannerND.Plo@am__quote@ @AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/UnfoldingFilterNDReader.Plo@am__quote@ @AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/UnitMapInterpolationND.Plo@am__quote@ @AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/VariableBandwidthSmoother1D.Plo@am__quote@ @AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/VerticallyInterpolatedDistribution1D.Plo@am__quote@ @AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/WeightTableFilter1DBuilder.Plo@am__quote@ @AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/WeightedStatAccumulator.Plo@am__quote@ @AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/WeightedStatAccumulatorPair.Plo@am__quote@ @AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/amiseOptimalBandwidth.Plo@am__quote@ @AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/buildInterpolatedHelpers.Plo@am__quote@ @AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/continuousDegreeTaper.Plo@am__quote@ @AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/convertAxis.Plo@am__quote@ @AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/correctDensityEstimateGHU.Plo@am__quote@ @AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/distributionReadError.Plo@am__quote@ @AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/distro1DStats.Plo@am__quote@ @AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/fitSbParameters.Plo@am__quote@ @AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/gaussianResponseMatrix.Plo@am__quote@ @AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/likelihoodStatisticCumulants.Plo@am__quote@ @AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/logLikelihoodPeak.Plo@am__quote@ @AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/lorpeMise1D.Plo@am__quote@ @AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/multinomialCovariance1D.Plo@am__quote@ @AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/neymanPearsonWindow1D.Plo@am__quote@ @AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/saddlepointDistribution1D.Plo@am__quote@ @AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/scanMultivariateDensityAsWeight.Plo@am__quote@ @AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/scanSymmetricDensityAsWeight.Plo@am__quote@ @AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/scannedKSDistance.Plo@am__quote@ @AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/statUncertainties.Plo@am__quote@ @AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/volumeDensityFromBinnedRadial.Plo@am__quote@ .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: $(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 -rf ./$(DEPDIR) -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 -rf ./$(DEPDIR) -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 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/StatUtils.hh =================================================================== --- trunk/npstat/stat/StatUtils.hh (revision 739) +++ trunk/npstat/stat/StatUtils.hh (revision 740) @@ -1,87 +1,95 @@ #ifndef NPSTAT_STATUTILS_HH_ #define NPSTAT_STATUTILS_HH_ /*! // \file StatUtils.hh // // \brief Statistical utilities which did not end up in dedicated headers // // Author: I. Volobouev // // March 2010 */ #include namespace npstat { /** // This function calculates an empirical quantile // from a _sorted_ vector of data points. If the "increaseRange" // parameter is "true" then the value returned for x = 0.0 // will be smaller than data[0] and the value returned for // x = 1.0 will be larger than the largest data value. */ template Data empiricalQuantile(const std::vector& data, double x, bool increaseRange=false); /** // The inverse to the npstat::empiricalQuantile (if there are no // duplicate entries in the data). The data vector must be sorted. */ template double empiricalCdf(const std::vector& data, const Data& x); /** // Find the bin number corresponding to the given cdf value in // an array which represents a cumulative distribution function // (the numbers in the array must increase). It is expected that // the "cdfValue" input is between cdf[0] and cdf[arrLen-1]. */ template unsigned long quantileBinFromCdf(const Data* cdf, unsigned long arrLen, Data cdfValue, Data* remainder = 0); /** // This function returns the mathematical functional R(d^n f(x)/d x^n), // where function f(x) is given by its tabulated values on a grid // with constant distance h between points (it is assumed that each // value is given in the middle of a cell, like in a histogram). The // functional R(y(x)) is, by definition, the integral of y(x) squared. // d^n f(x)/d x^n is the derivative of order n. // // Note that the table of function values is NOT preserved. */ template Real squaredDerivativeIntegral(Real* fvalues, unsigned long arrLen, unsigned n, Real h); /** // This function sets all negative elements of the input array to zero // and normalizes it so that the sum of the elements times the "binwidth" // argument becomes 1. If the input array is nowhere positive, // std::runtime_error is thrown. "true" is returned in case any negative // array elements are found, otherwise the function returns "false". // Upon exit (and if the "normfactor" pointer is not NULL), value of // *normfactor is set to the factor by which array elements are multiplied // so that they become normalized. */ template bool normalizeArrayAsDensity(Real* arr, unsigned long arrLen, double binwidth, double* normfactor=0); /** Akaike information criterion corrected for the sample size */ double aicc(const double ndof, const double logli, const double n); + /** + // The code for the distribution of Anderson-Darling test statistic comes + // from "Evaluating the Anderson-Darling Distribution" by G. Marsaglia and + // J. Marsaglia, Journal of Statistical Software, vol. 9, issue 2, + // pp. 1-5 (2004). + */ + double AD(const double n, const double z); + #ifdef SWIG inline bool normalizeArrayAsDensity_2(double* pyarr, unsigned long arrLen, double binwidth, double *OUTPUT) { return normalizeArrayAsDensity(pyarr, arrLen, binwidth, OUTPUT); } #endif // SWIG } #include "npstat/stat/StatUtils.icc" #endif // NPSTAT_STATUTILS_HH_ Index: trunk/npstat/stat/UnbinnedGOFTests1D.hh =================================================================== --- trunk/npstat/stat/UnbinnedGOFTests1D.hh (revision 739) +++ trunk/npstat/stat/UnbinnedGOFTests1D.hh (revision 740) @@ -1,36 +1,64 @@ #ifndef NPSTAT_UNBINNEDGOFTESTS1D_HH_ #define NPSTAT_UNBINNEDGOFTESTS1D_HH_ #include "npstat/stat/AbsUnbinnedGOFTest1D.hh" namespace npstat { + /** Kolmogorov-Smirnov test */ class KSTest1D : public AbsUnbinnedGOFTest1D { public: inline explicit KSTest1D(const AbsDistribution1D& d) : AbsUnbinnedGOFTest1D(d) {} inline virtual ~KSTest1D() {} inline virtual double testStatistic( const double* data, const unsigned long sz, const bool b) const {return testStat(data, sz, b);} inline virtual double testStatistic( const float* data, const unsigned long sz, const bool b) const {return testStat(data, sz, b);} inline virtual bool hasAnalyticPValue() const {return true;} virtual double analyticPValue(double stat, unsigned long sz) const; private: template double testStat(const Numeric* data, unsigned long lenData, bool dataIsSorted) const; }; + + /** Anderson-Darling test */ + class ADTest1D : public AbsUnbinnedGOFTest1D + { + public: + inline explicit ADTest1D(const AbsDistribution1D& d) + : AbsUnbinnedGOFTest1D(d) {} + + inline virtual ~ADTest1D() {} + + inline virtual double testStatistic( + const double* data, const unsigned long sz, const bool b) const + {return testStat(data, sz, b);} + + inline virtual double testStatistic( + const float* data, const unsigned long sz, const bool b) const + {return testStat(data, sz, b);} + + inline virtual bool hasAnalyticPValue() const {return true;} + + virtual double analyticPValue(double stat, unsigned long sz) const; + + private: + template + double testStat(const Numeric* data, unsigned long lenData, + bool dataIsSorted) const; + }; } #include "npstat/stat/UnbinnedGOFTests1D.icc" #endif // NPSTAT_UNBINNEDGOFTESTS1D_HH_ Index: trunk/npstat/stat/Makefile =================================================================== --- trunk/npstat/stat/Makefile (revision 739) +++ trunk/npstat/stat/Makefile (revision 740) @@ -1,1255 +1,1256 @@ # Makefile.in generated by automake 1.15.1 from Makefile.am. # npstat/stat/Makefile. Generated from Makefile.in by configure. # Copyright (C) 1994-2017 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 AbsCopulaSmootherBase.lo \ - BernsteinCopulaSmoother.lo distro1DStats.lo \ - SequentialGroupedCopulaSmoother.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 PolynomialDistro1D.lo \ AbsUnbinnedGOFTest1D.lo OrthoPolyGOFTest1D.lo \ UnbinnedGOFTests1D.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__depfiles_maybe = depfiles 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)` ETAGS = etags CTAGS = ctags 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.15 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.15 AWK = gawk CC = gcc CCDEPMODE = depmode=gcc3 CFLAGS = -g -O2 CPP = gcc -E CPPFLAGS = 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.3.0\" -DPACKAGE_STRING=\"npstat\ 5.3.0\" -DPACKAGE_BUGREPORT=\"\" -DPACKAGE_URL=\"\" -DPACKAGE=\"npstat\" -DVERSION=\"5.3.0\" -DSTDC_HEADERS=1 -DHAVE_SYS_TYPES_H=1 -DHAVE_SYS_STAT_H=1 -DHAVE_STDLIB_H=1 -DHAVE_STRING_H=1 -DHAVE_MEMORY_H=1 -DHAVE_STRINGS_H=1 -DHAVE_INTTYPES_H=1 -DHAVE_STDINT_H=1 -DHAVE_UNISTD_H=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 EXEEXT = F77 = g77 FFLAGS = -g -O2 FGREP = /bin/grep -F FLIBS = -L/usr/lib/gcc/x86_64-linux-gnu/7 -L/usr/lib/gcc/x86_64-linux-gnu/7/../../../x86_64-linux-gnu -L/usr/lib/gcc/x86_64-linux-gnu/7/../../../../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/7/../../.. -lgfortran -lm -lquadmath GREP = /bin/grep INSTALL = /usr/bin/install -c INSTALL_DATA = ${INSTALL} -m 644 INSTALL_PROGRAM = ${INSTALL} INSTALL_SCRIPT = ${INSTALL} INSTALL_STRIP_PROGRAM = $(install_sh) -c -s LD = /usr/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 = /usr/bin/nm -B NMEDIT = OBJDUMP = objdump OBJEXT = o OTOOL = OTOOL64 = PACKAGE = npstat PACKAGE_BUGREPORT = PACKAGE_NAME = npstat PACKAGE_STRING = npstat 5.3.0 PACKAGE_TARNAME = npstat PACKAGE_URL = PACKAGE_VERSION = 5.3.0 PATH_SEPARATOR = : PKG_CONFIG = /usr/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.3.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 \ + 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 \ PolynomialDistro1D.cc AbsUnbinnedGOFTest1D.cc OrthoPolyGOFTest1D.cc \ UnbinnedGOFTests1D.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 \ AbsSymbetaFilterProvider.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 \ BoundaryHandling.hh \ BoundaryMethod.hh \ buildInterpolatedCompositeDistroND.hh \ buildInterpolatedCompositeDistroND.icc \ buildInterpolatedDistro1DNP.hh \ buildInterpolatedDistro1DNP.icc \ buildInterpolatedHelpers.hh \ CensoredQuantileRegression.hh \ CensoredQuantileRegression.icc \ 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 \ 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 \ empiricalCopula.hh \ empiricalCopulaHisto.hh \ empiricalCopulaHisto.icc \ empiricalCopula.icc \ ExpTiltedDistribution1D.hh \ fillHistoFromText.hh \ fillHistoFromText.icc \ Filter1DBuilders.hh \ FitUtils.hh \ FitUtils.icc \ GaussianMixtureEntry.hh \ GaussianMixture1D.hh \ gaussianResponseMatrix.hh \ GCVCopulaSmoother.hh \ GCVCopulaSmoother.icc \ 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 \ JohnsonKDESmoother.hh \ KDE1D.hh \ KDE1DCV.hh \ KDE1DHOSymbetaKernel.hh \ KDECopulaSmoother.hh \ KDECopulaSmoother.icc \ KDEGroupedCopulaSmoother.hh \ KDEGroupedCopulaSmoother.icc \ KDEFilterND.hh \ KDEFilterND.icc \ kendallsTau.hh \ kendallsTau.icc \ kernelSensitivityMatrix.hh \ kernelSensitivityMatrix.icc \ LeftCensoredDistribution.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 \ logLikelihoodPeak.hh \ LogRatioTransform1D.hh \ LogTransform1D.hh \ LOrPECopulaSmoother.hh \ LOrPECopulaSmoother.icc \ LOrPEGroupedCopulaSmoother.hh \ LOrPEGroupedCopulaSmoother.icc \ LOrPEMarginalSmoother.hh \ lorpeBackgroundCVDensity1D.hh \ lorpeBackgroundCVDensity1D.icc \ lorpeBackground1D.hh \ lorpeBackground1D.icc \ lorpeMise1D.hh \ lorpeSmooth1D.hh \ lorpeSmooth1D.icc \ MatrixFilter1DBuilder.hh \ MemoizingSymbetaFilterProvider.hh \ mergeTwoHistos.hh \ mergeTwoHistos.icc \ mirrorWeight.hh \ MultiscaleEMUnfold1D.hh \ multinomialCovariance1D.hh \ MultivariateSumAccumulator.hh \ MultivariateSumsqAccumulator.hh \ MultivariateSumsqAccumulator.icc \ MultivariateWeightedSumAccumulator.hh \ MultivariateWeightedSumsqAccumulator.hh \ MultivariateWeightedSumsqAccumulator.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 \ NUHistoAxis.hh \ OrderedPointND.hh \ OrderedPointND.icc \ orthoPoly1DVProducts.hh \ orthoPoly1DVProducts.icc \ OrthoPolyGOFTest1D.hh \ OrthoPolyGOFTest1D.icc \ OSDE1D.hh \ OSDE1D.icc \ PearsonsChiSquared.hh \ PolyFilterCollection1D.hh \ PolynomialDistro1D.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 \ RatioOfNormals.hh \ RatioResponseBoxBuilder.hh \ RatioResponseBoxBuilder.icc \ RatioResponseIntervalBuilder.hh \ RatioResponseIntervalBuilder.icc \ ResponseMatrix.hh \ RightCensoredDistribution.hh \ saddlepointDistribution1D.hh \ SampleAccumulator.hh \ SampleAccumulator.icc \ SbMomentsCalculator.hh \ ScalableGaussND.hh \ scannedKSDistance.hh \ scanMultivariateDensityAsWeight.hh \ scanSymmetricDensityAsWeight.hh \ SequentialCopulaSmoother.hh \ SequentialCopulaSmoother.icc \ SequentialGroupedCopulaSmoother.hh \ SequentialGroupedCopulaSmoother.icc \ SequentialPolyFilterND.hh \ SequentialPolyFilterND.icc \ SeriesCGF1D.hh \ SinhAsinhTransform1D.hh \ SmoothedEMUnfold1D.hh \ SmoothedEMUnfoldND.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 \ TwoPointsLTSLoss.hh \ TwoPointsLTSLoss.icc \ UGaussConvolution1D.hh \ UnbinnedGOFTests1D.hh \ UnbinnedGOFTests1D.icc \ 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__depfiles_maybe)'; \ cd $(top_builddir) && $(SHELL) ./config.status $(subdir)/$@ $(am__depfiles_maybe);; \ 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 include ./$(DEPDIR)/AbsCGF1D.Plo include ./$(DEPDIR)/AbsCVCopulaSmoother.Plo include ./$(DEPDIR)/AbsCopulaSmootherBase.Plo include ./$(DEPDIR)/AbsDiscreteDistribution1D.Plo include ./$(DEPDIR)/AbsDistribution1D.Plo include ./$(DEPDIR)/AbsDistributionND.Plo include ./$(DEPDIR)/AbsDistributionTransform1D.Plo include ./$(DEPDIR)/AbsFilter1DBuilder.Plo include ./$(DEPDIR)/AbsKDE1DKernel.Plo include ./$(DEPDIR)/AbsMarginalSmootherBase.Plo include ./$(DEPDIR)/AbsNtuple.Plo include ./$(DEPDIR)/AbsUnbinnedGOFTest1D.Plo include ./$(DEPDIR)/AbsUnfold1D.Plo include ./$(DEPDIR)/AbsUnfoldND.Plo include ./$(DEPDIR)/AbsUnfoldingFilterND.Plo include ./$(DEPDIR)/AllSymbetaParams1D.Plo include ./$(DEPDIR)/AsinhTransform1D.Plo include ./$(DEPDIR)/BernsteinCopulaSmoother.Plo include ./$(DEPDIR)/BernsteinFilter1DBuilder.Plo include ./$(DEPDIR)/BetaFilter1DBuilder.Plo include ./$(DEPDIR)/BinSummary.Plo include ./$(DEPDIR)/BinnedADTest1D.Plo include ./$(DEPDIR)/BinnedKSTest1D.Plo include ./$(DEPDIR)/BoundaryHandling.Plo include ./$(DEPDIR)/ComparisonDistribution1D.Plo include ./$(DEPDIR)/CompositeDistribution1D.Plo include ./$(DEPDIR)/CompositeDistributionND.Plo include ./$(DEPDIR)/ConstantBandwidthSmoother1D.Plo include ./$(DEPDIR)/CopulaInterpolationND.Plo include ./$(DEPDIR)/Copulas.Plo include ./$(DEPDIR)/CrossCovarianceAccumulator.Plo include ./$(DEPDIR)/DeltaMixture1D.Plo include ./$(DEPDIR)/DensityOrthoPoly1D.Plo include ./$(DEPDIR)/DensityScan1D.Plo include ./$(DEPDIR)/DiscreteDistribution1DReader.Plo include ./$(DEPDIR)/DiscreteDistributions1D.Plo include ./$(DEPDIR)/DiscreteGauss1DBuilder.Plo include ./$(DEPDIR)/DiscreteGaussCopulaSmoother.Plo include ./$(DEPDIR)/Distribution1DFactory.Plo include ./$(DEPDIR)/Distribution1DReader.Plo include ./$(DEPDIR)/DistributionMix1D.Plo include ./$(DEPDIR)/DistributionMixND.Plo include ./$(DEPDIR)/DistributionNDReader.Plo include ./$(DEPDIR)/DistributionTransform1DReader.Plo include ./$(DEPDIR)/Distributions1D.Plo include ./$(DEPDIR)/DistributionsND.Plo include ./$(DEPDIR)/DualHistoAxis.Plo include ./$(DEPDIR)/EdgeworthSeries1D.Plo include ./$(DEPDIR)/EdgeworthSeriesMethod.Plo include ./$(DEPDIR)/ExpTiltedDistribution1D.Plo include ./$(DEPDIR)/Filter1DBuilders.Plo include ./$(DEPDIR)/GaussianMixture1D.Plo include ./$(DEPDIR)/GaussianMixtureEntry.Plo include ./$(DEPDIR)/GridInterpolatedDistribution.Plo include ./$(DEPDIR)/GridRandomizer.Plo include ./$(DEPDIR)/HistoAxis.Plo include ./$(DEPDIR)/HistoNDCdf.Plo include ./$(DEPDIR)/IdentityTransform1D.Plo include ./$(DEPDIR)/InterpolatedDistribution1D.Plo include ./$(DEPDIR)/InterpolatedDistro1D1P.Plo include ./$(DEPDIR)/InterpolatedDistro1DNP.Plo include ./$(DEPDIR)/JohnsonCurves.Plo include ./$(DEPDIR)/JohnsonKDESmoother.Plo include ./$(DEPDIR)/KDE1DHOSymbetaKernel.Plo include ./$(DEPDIR)/LOrPEMarginalSmoother.Plo include ./$(DEPDIR)/LeftCensoredDistribution.Plo include ./$(DEPDIR)/LikelihoodStatisticType.Plo include ./$(DEPDIR)/LocalMultiFilter1D.Plo include ./$(DEPDIR)/LocalPolyFilter1D.Plo include ./$(DEPDIR)/LocalPolyFilter1DReader.Plo include ./$(DEPDIR)/LocationScaleFamily1D.Plo include ./$(DEPDIR)/LogRatioTransform1D.Plo include ./$(DEPDIR)/LogTransform1D.Plo include ./$(DEPDIR)/MatrixFilter1DBuilder.Plo include ./$(DEPDIR)/MemoizingSymbetaFilterProvider.Plo include ./$(DEPDIR)/MultiscaleEMUnfold1D.Plo include ./$(DEPDIR)/NMCombinationSequencer.Plo include ./$(DEPDIR)/NUHistoAxis.Plo include ./$(DEPDIR)/OSDE1D.Plo include ./$(DEPDIR)/OrthoPolyGOFTest1D.Plo include ./$(DEPDIR)/PearsonsChiSquared.Plo include ./$(DEPDIR)/PolyFilterCollection1D.Plo include ./$(DEPDIR)/PolynomialDistro1D.Plo include ./$(DEPDIR)/ProductSymmetricBetaNDCdf.Plo include ./$(DEPDIR)/QuadraticOrthoPolyND.Plo include ./$(DEPDIR)/QuantileTable1D.Plo include ./$(DEPDIR)/RatioOfNormals.Plo include ./$(DEPDIR)/ResponseMatrix.Plo include ./$(DEPDIR)/RightCensoredDistribution.Plo include ./$(DEPDIR)/SbMomentsBigGamma.Plo include ./$(DEPDIR)/SbMomentsCalculator.Plo include ./$(DEPDIR)/ScalableGaussND.Plo include ./$(DEPDIR)/SequentialCopulaSmoother.Plo include ./$(DEPDIR)/SequentialGroupedCopulaSmoother.Plo include ./$(DEPDIR)/SequentialPolyFilterND.Plo include ./$(DEPDIR)/SeriesCGF1D.Plo include ./$(DEPDIR)/SinhAsinhTransform1D.Plo include ./$(DEPDIR)/SmoothedEMUnfold1D.Plo include ./$(DEPDIR)/SmoothedEMUnfoldND.Plo include ./$(DEPDIR)/StatAccumulator.Plo include ./$(DEPDIR)/StatAccumulatorArr.Plo include ./$(DEPDIR)/StatAccumulatorPair.Plo +include ./$(DEPDIR)/StatUtils.Plo include ./$(DEPDIR)/StorableMultivariateFunctor.Plo include ./$(DEPDIR)/StorableMultivariateFunctorReader.Plo include ./$(DEPDIR)/SymbetaParams1D.Plo include ./$(DEPDIR)/TransformedDistribution1D.Plo include ./$(DEPDIR)/TruncatedDistribution1D.Plo include ./$(DEPDIR)/UGaussConvolution1D.Plo include ./$(DEPDIR)/UnbinnedGOFTests1D.Plo include ./$(DEPDIR)/UnfoldingBandwidthScanner1D.Plo include ./$(DEPDIR)/UnfoldingBandwidthScannerND.Plo include ./$(DEPDIR)/UnfoldingFilterNDReader.Plo include ./$(DEPDIR)/UnitMapInterpolationND.Plo include ./$(DEPDIR)/VariableBandwidthSmoother1D.Plo include ./$(DEPDIR)/VerticallyInterpolatedDistribution1D.Plo include ./$(DEPDIR)/WeightTableFilter1DBuilder.Plo include ./$(DEPDIR)/WeightedStatAccumulator.Plo include ./$(DEPDIR)/WeightedStatAccumulatorPair.Plo include ./$(DEPDIR)/amiseOptimalBandwidth.Plo include ./$(DEPDIR)/buildInterpolatedHelpers.Plo include ./$(DEPDIR)/continuousDegreeTaper.Plo include ./$(DEPDIR)/convertAxis.Plo include ./$(DEPDIR)/correctDensityEstimateGHU.Plo include ./$(DEPDIR)/distributionReadError.Plo include ./$(DEPDIR)/distro1DStats.Plo include ./$(DEPDIR)/fitSbParameters.Plo include ./$(DEPDIR)/gaussianResponseMatrix.Plo include ./$(DEPDIR)/likelihoodStatisticCumulants.Plo include ./$(DEPDIR)/logLikelihoodPeak.Plo include ./$(DEPDIR)/lorpeMise1D.Plo include ./$(DEPDIR)/multinomialCovariance1D.Plo include ./$(DEPDIR)/neymanPearsonWindow1D.Plo include ./$(DEPDIR)/saddlepointDistribution1D.Plo include ./$(DEPDIR)/scanMultivariateDensityAsWeight.Plo include ./$(DEPDIR)/scanSymmetricDensityAsWeight.Plo include ./$(DEPDIR)/scannedKSDistance.Plo include ./$(DEPDIR)/statUncertainties.Plo include ./$(DEPDIR)/volumeDensityFromBinnedRadial.Plo .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: $(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 -rf ./$(DEPDIR) -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 -rf ./$(DEPDIR) -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 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.am =================================================================== --- trunk/npstat/stat/Makefile.am (revision 739) +++ trunk/npstat/stat/Makefile.am (revision 740) @@ -1,399 +1,399 @@ 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 \ + 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 \ PolynomialDistro1D.cc AbsUnbinnedGOFTest1D.cc OrthoPolyGOFTest1D.cc \ UnbinnedGOFTests1D.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 \ AbsSymbetaFilterProvider.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 \ BoundaryHandling.hh \ BoundaryMethod.hh \ buildInterpolatedCompositeDistroND.hh \ buildInterpolatedCompositeDistroND.icc \ buildInterpolatedDistro1DNP.hh \ buildInterpolatedDistro1DNP.icc \ buildInterpolatedHelpers.hh \ CensoredQuantileRegression.hh \ CensoredQuantileRegression.icc \ 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 \ 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 \ empiricalCopula.hh \ empiricalCopulaHisto.hh \ empiricalCopulaHisto.icc \ empiricalCopula.icc \ ExpTiltedDistribution1D.hh \ fillHistoFromText.hh \ fillHistoFromText.icc \ Filter1DBuilders.hh \ FitUtils.hh \ FitUtils.icc \ GaussianMixtureEntry.hh \ GaussianMixture1D.hh \ gaussianResponseMatrix.hh \ GCVCopulaSmoother.hh \ GCVCopulaSmoother.icc \ 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 \ JohnsonKDESmoother.hh \ KDE1D.hh \ KDE1DCV.hh \ KDE1DHOSymbetaKernel.hh \ KDECopulaSmoother.hh \ KDECopulaSmoother.icc \ KDEGroupedCopulaSmoother.hh \ KDEGroupedCopulaSmoother.icc \ KDEFilterND.hh \ KDEFilterND.icc \ kendallsTau.hh \ kendallsTau.icc \ kernelSensitivityMatrix.hh \ kernelSensitivityMatrix.icc \ LeftCensoredDistribution.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 \ logLikelihoodPeak.hh \ LogRatioTransform1D.hh \ LogTransform1D.hh \ LOrPECopulaSmoother.hh \ LOrPECopulaSmoother.icc \ LOrPEGroupedCopulaSmoother.hh \ LOrPEGroupedCopulaSmoother.icc \ LOrPEMarginalSmoother.hh \ lorpeBackgroundCVDensity1D.hh \ lorpeBackgroundCVDensity1D.icc \ lorpeBackground1D.hh \ lorpeBackground1D.icc \ lorpeMise1D.hh \ lorpeSmooth1D.hh \ lorpeSmooth1D.icc \ MatrixFilter1DBuilder.hh \ MemoizingSymbetaFilterProvider.hh \ mergeTwoHistos.hh \ mergeTwoHistos.icc \ mirrorWeight.hh \ MultiscaleEMUnfold1D.hh \ multinomialCovariance1D.hh \ MultivariateSumAccumulator.hh \ MultivariateSumsqAccumulator.hh \ MultivariateSumsqAccumulator.icc \ MultivariateWeightedSumAccumulator.hh \ MultivariateWeightedSumsqAccumulator.hh \ MultivariateWeightedSumsqAccumulator.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 \ NUHistoAxis.hh \ OrderedPointND.hh \ OrderedPointND.icc \ orthoPoly1DVProducts.hh \ orthoPoly1DVProducts.icc \ OrthoPolyGOFTest1D.hh \ OrthoPolyGOFTest1D.icc \ OSDE1D.hh \ OSDE1D.icc \ PearsonsChiSquared.hh \ PolyFilterCollection1D.hh \ PolynomialDistro1D.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 \ RatioOfNormals.hh \ RatioResponseBoxBuilder.hh \ RatioResponseBoxBuilder.icc \ RatioResponseIntervalBuilder.hh \ RatioResponseIntervalBuilder.icc \ ResponseMatrix.hh \ RightCensoredDistribution.hh \ saddlepointDistribution1D.hh \ SampleAccumulator.hh \ SampleAccumulator.icc \ SbMomentsCalculator.hh \ ScalableGaussND.hh \ scannedKSDistance.hh \ scanMultivariateDensityAsWeight.hh \ scanSymmetricDensityAsWeight.hh \ SequentialCopulaSmoother.hh \ SequentialCopulaSmoother.icc \ SequentialGroupedCopulaSmoother.hh \ SequentialGroupedCopulaSmoother.icc \ SequentialPolyFilterND.hh \ SequentialPolyFilterND.icc \ SeriesCGF1D.hh \ SinhAsinhTransform1D.hh \ SmoothedEMUnfold1D.hh \ SmoothedEMUnfoldND.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 \ TwoPointsLTSLoss.hh \ TwoPointsLTSLoss.icc \ UGaussConvolution1D.hh \ UnbinnedGOFTests1D.hh \ UnbinnedGOFTests1D.icc \ 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/BinnedADTest1D.cc =================================================================== --- trunk/npstat/stat/BinnedADTest1D.cc (revision 739) +++ trunk/npstat/stat/BinnedADTest1D.cc (revision 740) @@ -1,251 +1,178 @@ #include #include #include #include #include "npstat/nm/allocators.hh" + #include "npstat/rng/AbsRandomGenerator.hh" + #include "npstat/stat/BinnedADTest1D.hh" #include "npstat/stat/DiscreteDistributions1D.hh" - -// The code for the distribution of Anderson-Darling test statistic comes -// from "Evaluating the Anderson-Darling Distribution" by G. Marsaglia and -// J. Marsaglia, Journal of Statistical Software, vol. 9, issue 2, -// pp. 1-5 (2004). -static double ADf(const double z, const int j) -{ - const double t = (4*j+1)*(4*j+1)*1.23370055013617/z; - if (t > 150.0) - return 0.0; - double a = 2.22144146907918*exp(-t)/sqrt(t); - // double b = 3.93740248643060*2.*cPhi(sqrt(2*t)); /* requires cPhi */ - /*if you have erfc(), replace 2*cPhi(sqrt(2*t)) with erfc(sqrt(t))*/ - double b = 3.93740248643060*erfc(sqrt(t)); - double r = z*.125; - double f = a+b*r; - for (int i=1; i<200; i++) - { - const double c = ((i-.5-t)*b+t*a)/i; - a=b; b=c; - r *= z/(8*i+8); - if (fabs(r) < 1.e-40 || fabs(c) < 1.e-40) - return f; - const double fnew = f+c*r; - if (f == fnew) - return f; - f = fnew; - } - return f; -} - -static double ADinf(const double z) -{ - if (z < 0.01) - return 0.0; /* avoids exponent limits; ADinf(.01)=.528e-52 */ - if (z > 32.0) - return 1.0; - - double r = 1.0/z; - double ad = r*ADf(z, 0); - for (int j=1; j<100; j++) - { - r *= (0.5 - j)/j; - const double adnew = ad+(4*j+1)*r*ADf(z,j); - if (ad == adnew) - return ad; - ad = adnew; - } - return ad; -} - -static double AD(const double n, const double z) -{ - const double x = ADinf(z); - - /* now x=adinf(z). Next, get v=errfix(n,x) and return x+v; */ - if (x > 0.8) - { - const double v=(-130.2137+(745.2337-(1705.091-(1950.646-(1116.360-255.7844*x)*x)*x)*x)*x)/n; - return x+v; - } - - const double c=.01265+.1757/n; - if (x < c) - { - double v = x/c; - v=sqrt(v)*(1.-v)*(49*v-102); - return x+v*(.0037/n/n + .00078/n + .00006)/n; - } - else - { - double v = (x-c)/(.8-c); - v=-.00022633+(6.54034-(14.6538-(14.458-(8.259-1.91864*v)*v)*v)*v)*v; - return x+v*(.04213+.01365/n)/n; - } -} +#include "npstat/stat/StatUtils.hh" namespace { struct DiscreteADDistance : public npstat::AbsDiscreteDistribution1DDistance { double operator()(const npstat::AbsDiscreteDistribution1D& data, const npstat::AbsDiscreteDistribution1D& data2, const npstat::AbsDiscreteDistribution1D* pooled, const long first, const long last) const { const npstat::AbsDiscreteDistribution1D& ref = (pooled ? *pooled : data2); long double sum = 0.0L; double oldRefCdf = 0.0; double oldRefExceedance = 1.0; double oldDataCdf = 0.0; double oldDataExceedance = 1.0; double oldData2Cdf = 0.0; double oldData2Exceedance = 1.0; bool useExceedance = false; double cdfCenterData = 0.0, excCenterData = 0.0; double cdfCenterData2 = 0.0, excCenterData2 = 0.0; for (long i=first; i 0.5); } if (prob > 0.0) { double delta; if (pooled) { if (useExceedance) delta = excCenterData - excCenterData2; else delta = cdfCenterData - cdfCenterData2; } else { if (useExceedance) delta = excCenterData - excCenterRef; else delta = cdfCenterData - cdfCenterRef; } sum += prob*delta*delta/cdfCenterRef/excCenterRef; } } return sum; } }; } namespace npstat { BinnedADTest1D::BinnedADTest1D(const bool useTwoSampleTest, AbsRandomGenerator* rng, const unsigned mcSamplesForPValue) : rng_(rng), mcSamples_(mcSamplesForPValue), twoSampleTest_(useTwoSampleTest) { } const char* BinnedADTest1D::name() const { if (name_.empty()) { std::ostringstream os; if (twoSampleTest_) os << "Two-sample "; os << "Anderson-Darling"; if (rng_ && mcSamples_) os << " by MC"; name_ = os.str(); } return name_.c_str(); } void BinnedADTest1D::compareD(const double* pdata, const double* preference, const unsigned len, double* distance, double* pvalue) const { DiscreteTabulated1D data(0, pdata, len); DiscreteTabulated1D ref(0, preference, len); DiscreteADDistance calc; const double dData = std::accumulate(pdata, pdata+len, 0.0L); double dist = 0.0, dRef = 0.0; if (twoSampleTest_) { dRef = std::accumulate(preference, preference+len, 0.0L); const DiscreteTabulated1D& pooled = pooledDiscreteTabulated1D( data, dData, ref, dRef, 0L, len); dist = calc(data, ref, &pooled, 0L, len); } else dist = calc(data, ref, 0, 0L, len); if (distance) *distance = dist; if (pvalue) { if (rng_ && mcSamples_) { // Calculate the p-value by MC *pvalue = pvalueByPseudo(calc, *rng_, data, dData, ref, dRef, dist, mcSamples_); } else { const double nEff = twoSampleTest_ ? dData*dRef/(dData + dRef) : dData; *pvalue = 1.0 - AD(nEff, nEff*dist); if (*pvalue > 1.0) *pvalue = 1.0; } } } } Index: trunk/config.log =================================================================== --- trunk/config.log (revision 739) +++ trunk/config.log (revision 740) @@ -1,943 +1,943 @@ 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.3.0, which was generated by GNU Autoconf 2.69. Invocation command line was $ ./configure --disable-static --with-pic ## --------- ## ## Platform. ## ## --------- ## hostname = dawn uname -m = x86_64 uname -r = 4.15.0-122-generic uname -s = Linux uname -v = #124-Ubuntu SMP Thu Oct 15 13:03:05 UTC 2020 /usr/bin/uname -p = unknown /bin/uname -X = unknown /bin/arch = unknown /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:2421: checking for a BSD-compatible install configure:2489: result: /usr/bin/install -c configure:2500: checking whether build environment is sane configure:2555: result: yes configure:2706: checking for a thread-safe mkdir -p configure:2745: result: /bin/mkdir -p configure:2752: checking for gawk configure:2768: found /usr/bin/gawk configure:2779: result: gawk configure:2790: checking whether make sets $(MAKE) configure:2812: result: yes configure:2841: checking whether make supports nested variables configure:2858: result: yes configure:3042: checking for pkg-config configure:3060: found /usr/bin/pkg-config configure:3072: result: /usr/bin/pkg-config configure:3097: checking pkg-config is at least version 0.9.0 configure:3100: result: yes configure:3110: checking for DEPS configure:3117: $PKG_CONFIG --exists --print-errors "fftw3 >= 3.1.2 geners >= 1.3.0 kstest >= 2.0.0" configure:3120: $? = 0 configure:3134: $PKG_CONFIG --exists --print-errors "fftw3 >= 3.1.2 geners >= 1.3.0 kstest >= 2.0.0" configure:3137: $? = 0 configure:3195: result: yes configure:3258: checking for g++ configure:3274: found /usr/bin/g++ configure:3285: result: g++ configure:3312: checking for C++ compiler version configure:3321: g++ --version >&5 g++ (Ubuntu 7.5.0-3ubuntu1~18.04) 7.5.0 Copyright (C) 2017 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:3332: $? = 0 configure:3321: g++ -v >&5 Using built-in specs. COLLECT_GCC=g++ COLLECT_LTO_WRAPPER=/usr/lib/gcc/x86_64-linux-gnu/7/lto-wrapper OFFLOAD_TARGET_NAMES=nvptx-none OFFLOAD_TARGET_DEFAULT=1 Target: x86_64-linux-gnu Configured with: ../src/configure -v --with-pkgversion='Ubuntu 7.5.0-3ubuntu1~18.04' --with-bugurl=file:///usr/share/doc/gcc-7/README.Bugs --enable-languages=c,ada,c++,go,brig,d,fortran,objc,obj-c++ --prefix=/usr --with-gcc-major-version-only --program-suffix=-7 --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-libmpx --enable-plugin --enable-default-pie --with-system-zlib --with-target-system-zlib --enable-objc-gc=auto --enable-multiarch --disable-werror --with-arch-32=i686 --with-abi=m64 --with-multilib-list=m32,m64,mx32 --enable-multilib --with-tune=generic --enable-offload-targets=nvptx-none --without-cuda-driver --enable-checking=release --build=x86_64-linux-gnu --host=x86_64-linux-gnu --target=x86_64-linux-gnu Thread model: posix gcc version 7.5.0 (Ubuntu 7.5.0-3ubuntu1~18.04) configure:3332: $? = 0 configure:3321: g++ -V >&5 g++: error: unrecognized command line option '-V' g++: fatal error: no input files compilation terminated. configure:3332: $? = 1 configure:3321: g++ -qversion >&5 g++: error: unrecognized command line option '-qversion'; did you mean '--version'? g++: fatal error: no input files compilation terminated. configure:3332: $? = 1 configure:3352: checking whether the C++ compiler works configure:3374: g++ -std=c++11 -O3 -Wall -W -Werror conftest.cpp >&5 configure:3378: $? = 0 configure:3426: result: yes configure:3429: checking for C++ compiler default output file name configure:3431: result: a.out configure:3437: checking for suffix of executables configure:3444: g++ -o conftest -std=c++11 -O3 -Wall -W -Werror conftest.cpp >&5 configure:3448: $? = 0 configure:3470: result: configure:3492: checking whether we are cross compiling configure:3500: g++ -o conftest -std=c++11 -O3 -Wall -W -Werror conftest.cpp >&5 configure:3504: $? = 0 configure:3511: ./conftest configure:3515: $? = 0 configure:3530: result: no configure:3535: checking for suffix of object files configure:3557: g++ -c -std=c++11 -O3 -Wall -W -Werror conftest.cpp >&5 configure:3561: $? = 0 configure:3582: result: o configure:3586: checking whether we are using the GNU C++ compiler configure:3605: g++ -c -std=c++11 -O3 -Wall -W -Werror conftest.cpp >&5 configure:3605: $? = 0 configure:3614: result: yes configure:3623: checking whether g++ accepts -g configure:3643: g++ -c -g conftest.cpp >&5 configure:3643: $? = 0 configure:3684: result: yes configure:3718: checking for style of include used by make configure:3746: result: GNU configure:3772: checking dependency style of g++ configure:3883: result: gcc3 configure:3952: checking for g77 configure:3968: found /home/igv/bin/g77 configure:3979: result: g77 configure:4005: checking for Fortran 77 compiler version configure:4014: g77 --version >&5 GNU Fortran (Ubuntu 7.5.0-3ubuntu1~18.04) 7.5.0 Copyright (C) 2017 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:4025: $? = 0 configure:4014: g77 -v >&5 Using built-in specs. COLLECT_GCC=g77 COLLECT_LTO_WRAPPER=/usr/lib/gcc/x86_64-linux-gnu/7/lto-wrapper OFFLOAD_TARGET_NAMES=nvptx-none OFFLOAD_TARGET_DEFAULT=1 Target: x86_64-linux-gnu Configured with: ../src/configure -v --with-pkgversion='Ubuntu 7.5.0-3ubuntu1~18.04' --with-bugurl=file:///usr/share/doc/gcc-7/README.Bugs --enable-languages=c,ada,c++,go,brig,d,fortran,objc,obj-c++ --prefix=/usr --with-gcc-major-version-only --program-suffix=-7 --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-libmpx --enable-plugin --enable-default-pie --with-system-zlib --with-target-system-zlib --enable-objc-gc=auto --enable-multiarch --disable-werror --with-arch-32=i686 --with-abi=m64 --with-multilib-list=m32,m64,mx32 --enable-multilib --with-tune=generic --enable-offload-targets=nvptx-none --without-cuda-driver --enable-checking=release --build=x86_64-linux-gnu --host=x86_64-linux-gnu --target=x86_64-linux-gnu Thread model: posix gcc version 7.5.0 (Ubuntu 7.5.0-3ubuntu1~18.04) configure:4025: $? = 0 configure:4014: g77 -V >&5 g77: error: unrecognized command line option '-V' g77: fatal error: no input files compilation terminated. configure:4025: $? = 1 configure:4014: g77 -qversion >&5 g77: error: unrecognized command line option '-qversion'; did you mean '--version'? g77: fatal error: no input files compilation terminated. configure:4025: $? = 1 configure:4034: checking whether we are using the GNU Fortran 77 compiler configure:4047: g77 -c conftest.F >&5 configure:4047: $? = 0 configure:4056: result: yes configure:4062: checking whether g77 accepts -g configure:4073: g77 -c -g conftest.f >&5 configure:4073: $? = 0 configure:4081: result: yes configure:4114: checking build system type configure:4128: result: x86_64-pc-linux-gnu configure:4148: checking host system type configure:4161: result: x86_64-pc-linux-gnu configure:4186: checking how to get verbose linking output from g77 configure:4196: g77 -c -g -O2 conftest.f >&5 configure:4196: $? = 0 configure:4214: g77 -o conftest -g -O2 -v conftest.f Using built-in specs. Target: x86_64-linux-gnu Thread model: posix gcc version 7.5.0 (Ubuntu 7.5.0-3ubuntu1~18.04) - /usr/lib/gcc/x86_64-linux-gnu/7/f951 conftest.f -ffixed-form -quiet -dumpbase conftest.f -mtune=generic -march=x86-64 -auxbase conftest -g -O2 -version -fintrinsic-modules-path /usr/lib/gcc/x86_64-linux-gnu/7/finclude -o /tmp/ccUDY7iA.s + /usr/lib/gcc/x86_64-linux-gnu/7/f951 conftest.f -ffixed-form -quiet -dumpbase conftest.f -mtune=generic -march=x86-64 -auxbase conftest -g -O2 -version -fintrinsic-modules-path /usr/lib/gcc/x86_64-linux-gnu/7/finclude -o /tmp/ccpThqMh.s GNU Fortran (Ubuntu 7.5.0-3ubuntu1~18.04) version 7.5.0 (x86_64-linux-gnu) compiled by GNU C version 7.5.0, GMP version 6.1.2, MPFR version 4.0.1, MPC version 1.1.0, isl version isl-0.19-GMP GGC heuristics: --param ggc-min-expand=100 --param ggc-min-heapsize=131072 GNU Fortran2008 (Ubuntu 7.5.0-3ubuntu1~18.04) version 7.5.0 (x86_64-linux-gnu) compiled by GNU C version 7.5.0, GMP version 6.1.2, MPFR version 4.0.1, MPC version 1.1.0, isl version isl-0.19-GMP GGC heuristics: --param ggc-min-expand=100 --param ggc-min-heapsize=131072 - as -v --64 -o /tmp/ccauQ6AU.o /tmp/ccUDY7iA.s + as -v --64 -o /tmp/ccQMTotw.o /tmp/ccpThqMh.s GNU assembler version 2.30 (x86_64-linux-gnu) using BFD version (GNU Binutils for Ubuntu) 2.30 Reading specs from /usr/lib/gcc/x86_64-linux-gnu/7/libgfortran.spec rename spec lib to liborig - /usr/lib/gcc/x86_64-linux-gnu/7/collect2 -plugin /usr/lib/gcc/x86_64-linux-gnu/7/liblto_plugin.so -plugin-opt=/usr/lib/gcc/x86_64-linux-gnu/7/lto-wrapper -plugin-opt=-fresolution=/tmp/ccB8LRTe.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/7/../../../x86_64-linux-gnu/Scrt1.o /usr/lib/gcc/x86_64-linux-gnu/7/../../../x86_64-linux-gnu/crti.o /usr/lib/gcc/x86_64-linux-gnu/7/crtbeginS.o -L/usr/lib/gcc/x86_64-linux-gnu/7 -L/usr/lib/gcc/x86_64-linux-gnu/7/../../../x86_64-linux-gnu -L/usr/lib/gcc/x86_64-linux-gnu/7/../../../../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/7/../../.. /tmp/ccauQ6AU.o -lgfortran -lm -lgcc_s -lgcc -lquadmath -lm -lgcc_s -lgcc -lc -lgcc_s -lgcc /usr/lib/gcc/x86_64-linux-gnu/7/crtendS.o /usr/lib/gcc/x86_64-linux-gnu/7/../../../x86_64-linux-gnu/crtn.o + /usr/lib/gcc/x86_64-linux-gnu/7/collect2 -plugin /usr/lib/gcc/x86_64-linux-gnu/7/liblto_plugin.so -plugin-opt=/usr/lib/gcc/x86_64-linux-gnu/7/lto-wrapper -plugin-opt=-fresolution=/tmp/ccr3sqbL.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/7/../../../x86_64-linux-gnu/Scrt1.o /usr/lib/gcc/x86_64-linux-gnu/7/../../../x86_64-linux-gnu/crti.o /usr/lib/gcc/x86_64-linux-gnu/7/crtbeginS.o -L/usr/lib/gcc/x86_64-linux-gnu/7 -L/usr/lib/gcc/x86_64-linux-gnu/7/../../../x86_64-linux-gnu -L/usr/lib/gcc/x86_64-linux-gnu/7/../../../../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/7/../../.. /tmp/ccQMTotw.o -lgfortran -lm -lgcc_s -lgcc -lquadmath -lm -lgcc_s -lgcc -lc -lgcc_s -lgcc /usr/lib/gcc/x86_64-linux-gnu/7/crtendS.o /usr/lib/gcc/x86_64-linux-gnu/7/../../../x86_64-linux-gnu/crtn.o configure:4297: result: -v configure:4299: checking for Fortran 77 libraries of g77 configure:4322: g77 -o conftest -g -O2 -v conftest.f Using built-in specs. Target: x86_64-linux-gnu Thread model: posix gcc version 7.5.0 (Ubuntu 7.5.0-3ubuntu1~18.04) - /usr/lib/gcc/x86_64-linux-gnu/7/f951 conftest.f -ffixed-form -quiet -dumpbase conftest.f -mtune=generic -march=x86-64 -auxbase conftest -g -O2 -version -fintrinsic-modules-path /usr/lib/gcc/x86_64-linux-gnu/7/finclude -o /tmp/cc6sc67B.s + /usr/lib/gcc/x86_64-linux-gnu/7/f951 conftest.f -ffixed-form -quiet -dumpbase conftest.f -mtune=generic -march=x86-64 -auxbase conftest -g -O2 -version -fintrinsic-modules-path /usr/lib/gcc/x86_64-linux-gnu/7/finclude -o /tmp/cc19Zt5l.s GNU Fortran (Ubuntu 7.5.0-3ubuntu1~18.04) version 7.5.0 (x86_64-linux-gnu) compiled by GNU C version 7.5.0, GMP version 6.1.2, MPFR version 4.0.1, MPC version 1.1.0, isl version isl-0.19-GMP GGC heuristics: --param ggc-min-expand=100 --param ggc-min-heapsize=131072 GNU Fortran2008 (Ubuntu 7.5.0-3ubuntu1~18.04) version 7.5.0 (x86_64-linux-gnu) compiled by GNU C version 7.5.0, GMP version 6.1.2, MPFR version 4.0.1, MPC version 1.1.0, isl version isl-0.19-GMP GGC heuristics: --param ggc-min-expand=100 --param ggc-min-heapsize=131072 - as -v --64 -o /tmp/cc8yZByW.o /tmp/cc6sc67B.s + as -v --64 -o /tmp/cc2WqJXA.o /tmp/cc19Zt5l.s GNU assembler version 2.30 (x86_64-linux-gnu) using BFD version (GNU Binutils for Ubuntu) 2.30 Reading specs from /usr/lib/gcc/x86_64-linux-gnu/7/libgfortran.spec rename spec lib to liborig - /usr/lib/gcc/x86_64-linux-gnu/7/collect2 -plugin /usr/lib/gcc/x86_64-linux-gnu/7/liblto_plugin.so -plugin-opt=/usr/lib/gcc/x86_64-linux-gnu/7/lto-wrapper -plugin-opt=-fresolution=/tmp/cc2WCTZg.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/7/../../../x86_64-linux-gnu/Scrt1.o /usr/lib/gcc/x86_64-linux-gnu/7/../../../x86_64-linux-gnu/crti.o /usr/lib/gcc/x86_64-linux-gnu/7/crtbeginS.o -L/usr/lib/gcc/x86_64-linux-gnu/7 -L/usr/lib/gcc/x86_64-linux-gnu/7/../../../x86_64-linux-gnu -L/usr/lib/gcc/x86_64-linux-gnu/7/../../../../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/7/../../.. /tmp/cc8yZByW.o -lgfortran -lm -lgcc_s -lgcc -lquadmath -lm -lgcc_s -lgcc -lc -lgcc_s -lgcc /usr/lib/gcc/x86_64-linux-gnu/7/crtendS.o /usr/lib/gcc/x86_64-linux-gnu/7/../../../x86_64-linux-gnu/crtn.o + /usr/lib/gcc/x86_64-linux-gnu/7/collect2 -plugin /usr/lib/gcc/x86_64-linux-gnu/7/liblto_plugin.so -plugin-opt=/usr/lib/gcc/x86_64-linux-gnu/7/lto-wrapper -plugin-opt=-fresolution=/tmp/ccDXbVQP.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/7/../../../x86_64-linux-gnu/Scrt1.o /usr/lib/gcc/x86_64-linux-gnu/7/../../../x86_64-linux-gnu/crti.o /usr/lib/gcc/x86_64-linux-gnu/7/crtbeginS.o -L/usr/lib/gcc/x86_64-linux-gnu/7 -L/usr/lib/gcc/x86_64-linux-gnu/7/../../../x86_64-linux-gnu -L/usr/lib/gcc/x86_64-linux-gnu/7/../../../../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/7/../../.. /tmp/cc2WqJXA.o -lgfortran -lm -lgcc_s -lgcc -lquadmath -lm -lgcc_s -lgcc -lc -lgcc_s -lgcc /usr/lib/gcc/x86_64-linux-gnu/7/crtendS.o /usr/lib/gcc/x86_64-linux-gnu/7/../../../x86_64-linux-gnu/crtn.o configure:4518: result: -L/usr/lib/gcc/x86_64-linux-gnu/7 -L/usr/lib/gcc/x86_64-linux-gnu/7/../../../x86_64-linux-gnu -L/usr/lib/gcc/x86_64-linux-gnu/7/../../../../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/7/../../.. -lgfortran -lm -lquadmath configure:4580: checking how to print strings configure:4607: result: printf configure:4676: checking for gcc configure:4692: found /usr/bin/gcc configure:4703: result: gcc configure:4932: checking for C compiler version configure:4941: gcc --version >&5 gcc (Ubuntu 7.5.0-3ubuntu1~18.04) 7.5.0 Copyright (C) 2017 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:4952: $? = 0 configure:4941: gcc -v >&5 Using built-in specs. COLLECT_GCC=gcc COLLECT_LTO_WRAPPER=/usr/lib/gcc/x86_64-linux-gnu/7/lto-wrapper OFFLOAD_TARGET_NAMES=nvptx-none OFFLOAD_TARGET_DEFAULT=1 Target: x86_64-linux-gnu Configured with: ../src/configure -v --with-pkgversion='Ubuntu 7.5.0-3ubuntu1~18.04' --with-bugurl=file:///usr/share/doc/gcc-7/README.Bugs --enable-languages=c,ada,c++,go,brig,d,fortran,objc,obj-c++ --prefix=/usr --with-gcc-major-version-only --program-suffix=-7 --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-libmpx --enable-plugin --enable-default-pie --with-system-zlib --with-target-system-zlib --enable-objc-gc=auto --enable-multiarch --disable-werror --with-arch-32=i686 --with-abi=m64 --with-multilib-list=m32,m64,mx32 --enable-multilib --with-tune=generic --enable-offload-targets=nvptx-none --without-cuda-driver --enable-checking=release --build=x86_64-linux-gnu --host=x86_64-linux-gnu --target=x86_64-linux-gnu Thread model: posix gcc version 7.5.0 (Ubuntu 7.5.0-3ubuntu1~18.04) configure:4952: $? = 0 configure:4941: gcc -V >&5 gcc: error: unrecognized command line option '-V' gcc: fatal error: no input files compilation terminated. configure:4952: $? = 1 configure:4941: gcc -qversion >&5 gcc: error: unrecognized command line option '-qversion'; did you mean '--version'? gcc: fatal error: no input files compilation terminated. configure:4952: $? = 1 configure:4956: checking whether we are using the GNU C compiler configure:4975: gcc -c conftest.c >&5 configure:4975: $? = 0 configure:4984: result: yes configure:4993: checking whether gcc accepts -g configure:5013: gcc -c -g conftest.c >&5 configure:5013: $? = 0 configure:5054: result: yes configure:5071: checking for gcc option to accept ISO C89 configure:5134: gcc -c -g -O2 conftest.c >&5 configure:5134: $? = 0 configure:5147: result: none needed configure:5172: checking whether gcc understands -c and -o together configure:5194: gcc -c conftest.c -o conftest2.o configure:5197: $? = 0 configure:5194: gcc -c conftest.c -o conftest2.o configure:5197: $? = 0 configure:5209: result: yes configure:5228: checking dependency style of gcc configure:5339: result: gcc3 configure:5354: checking for a sed that does not truncate output configure:5418: result: /bin/sed configure:5436: checking for grep that handles long lines and -e configure:5494: result: /bin/grep configure:5499: checking for egrep configure:5561: result: /bin/grep -E configure:5566: checking for fgrep configure:5628: result: /bin/grep -F configure:5663: checking for ld used by gcc configure:5730: result: /usr/bin/ld configure:5737: checking if the linker (/usr/bin/ld) is GNU ld configure:5752: result: yes configure:5764: checking for BSD- or MS-compatible name lister (nm) configure:5818: result: /usr/bin/nm -B configure:5948: checking the name lister (/usr/bin/nm -B) interface configure:5955: gcc -c -g -O2 conftest.c >&5 configure:5958: /usr/bin/nm -B "conftest.o" configure:5961: output 0000000000000000 B some_variable configure:5968: result: BSD nm configure:5971: checking whether ln -s works configure:5975: result: yes configure:5983: checking the maximum length of command line arguments configure:6114: result: 1572864 configure:6162: checking how to convert x86_64-pc-linux-gnu file names to x86_64-pc-linux-gnu format configure:6202: result: func_convert_file_noop configure:6209: checking how to convert x86_64-pc-linux-gnu file names to toolchain format configure:6229: result: func_convert_file_noop configure:6236: checking for /usr/bin/ld option to reload object files configure:6243: result: -r configure:6317: checking for objdump configure:6333: found /usr/bin/objdump configure:6344: result: objdump configure:6376: checking how to recognize dependent libraries configure:6576: result: pass_all configure:6661: checking for dlltool configure:6691: result: no configure:6721: checking how to associate runtime and link libraries configure:6748: result: printf %s\n configure:6809: checking for ar configure:6825: found /usr/bin/ar configure:6836: result: ar configure:6873: checking for archiver @FILE support configure:6890: gcc -c -g -O2 conftest.c >&5 configure:6890: $? = 0 configure:6893: ar cru libconftest.a @conftest.lst >&5 ar: `u' modifier ignored since `D' is the default (see `U') configure:6896: $? = 0 configure:6901: ar cru libconftest.a @conftest.lst >&5 ar: `u' modifier ignored since `D' is the default (see `U') ar: conftest.o: No such file or directory configure:6904: $? = 1 configure:6916: result: @ configure:6974: checking for strip configure:6990: found /usr/bin/strip configure:7001: result: strip configure:7073: checking for ranlib configure:7089: found /usr/bin/ranlib configure:7100: result: ranlib configure:7202: checking command to parse /usr/bin/nm -B output from gcc object configure:7355: gcc -c -g -O2 conftest.c >&5 configure:7358: $? = 0 configure:7362: /usr/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:7365: $? = 0 configure:7431: gcc -o conftest -g -O2 conftest.c conftstm.o >&5 configure:7434: $? = 0 configure:7472: result: ok configure:7519: checking for sysroot configure:7549: result: no configure:7556: checking for a working dd configure:7594: result: /bin/dd configure:7598: checking how to truncate binary pipes configure:7613: result: /bin/dd bs=4096 count=1 configure:7749: gcc -c -g -O2 conftest.c >&5 configure:7752: $? = 0 configure:7942: checking for mt configure:7958: found /bin/mt configure:7969: result: mt configure:7992: checking if mt is a manifest tool configure:7998: mt '-?' configure:8006: result: no configure:8683: checking how to run the C preprocessor configure:8714: gcc -E conftest.c configure:8714: $? = 0 configure:8728: gcc -E conftest.c conftest.c:11:10: fatal error: ac_nonexistent.h: No such file or directory #include ^~~~~~~~~~~~~~~~~~ compilation terminated. configure:8728: $? = 1 configure: failed program was: | /* confdefs.h */ | #define PACKAGE_NAME "npstat" | #define PACKAGE_TARNAME "npstat" | #define PACKAGE_VERSION "5.3.0" | #define PACKAGE_STRING "npstat 5.3.0" | #define PACKAGE_BUGREPORT "" | #define PACKAGE_URL "" | #define PACKAGE "npstat" | #define VERSION "5.3.0" | /* end confdefs.h. */ | #include configure:8753: result: gcc -E configure:8773: gcc -E conftest.c configure:8773: $? = 0 configure:8787: gcc -E conftest.c conftest.c:11:10: fatal error: ac_nonexistent.h: No such file or directory #include ^~~~~~~~~~~~~~~~~~ compilation terminated. configure:8787: $? = 1 configure: failed program was: | /* confdefs.h */ | #define PACKAGE_NAME "npstat" | #define PACKAGE_TARNAME "npstat" | #define PACKAGE_VERSION "5.3.0" | #define PACKAGE_STRING "npstat 5.3.0" | #define PACKAGE_BUGREPORT "" | #define PACKAGE_URL "" | #define PACKAGE "npstat" | #define VERSION "5.3.0" | /* end confdefs.h. */ | #include configure:8816: checking for ANSI C header files configure:8836: gcc -c -g -O2 conftest.c >&5 configure:8836: $? = 0 configure:8909: gcc -o conftest -g -O2 conftest.c >&5 configure:8909: $? = 0 configure:8909: ./conftest configure:8909: $? = 0 configure:8920: result: yes configure:8933: checking for sys/types.h configure:8933: gcc -c -g -O2 conftest.c >&5 configure:8933: $? = 0 configure:8933: result: yes configure:8933: checking for sys/stat.h configure:8933: gcc -c -g -O2 conftest.c >&5 configure:8933: $? = 0 configure:8933: result: yes configure:8933: checking for stdlib.h configure:8933: gcc -c -g -O2 conftest.c >&5 configure:8933: $? = 0 configure:8933: result: yes configure:8933: checking for string.h configure:8933: gcc -c -g -O2 conftest.c >&5 configure:8933: $? = 0 configure:8933: result: yes configure:8933: checking for memory.h configure:8933: gcc -c -g -O2 conftest.c >&5 configure:8933: $? = 0 configure:8933: result: yes configure:8933: checking for strings.h configure:8933: gcc -c -g -O2 conftest.c >&5 configure:8933: $? = 0 configure:8933: result: yes configure:8933: checking for inttypes.h configure:8933: gcc -c -g -O2 conftest.c >&5 configure:8933: $? = 0 configure:8933: result: yes configure:8933: checking for stdint.h configure:8933: gcc -c -g -O2 conftest.c >&5 configure:8933: $? = 0 configure:8933: result: yes configure:8933: checking for unistd.h configure:8933: gcc -c -g -O2 conftest.c >&5 configure:8933: $? = 0 configure:8933: result: yes configure:8947: checking for dlfcn.h configure:8947: gcc -c -g -O2 conftest.c >&5 configure:8947: $? = 0 configure:8947: result: yes configure:9214: checking for objdir configure:9229: result: .libs configure:9493: checking if gcc supports -fno-rtti -fno-exceptions configure:9511: gcc -c -g -O2 -fno-rtti -fno-exceptions conftest.c >&5 cc1: warning: command line option '-fno-rtti' is valid for C++/ObjC++ but not for C configure:9515: $? = 0 configure:9528: result: no configure:9886: checking for gcc option to produce PIC configure:9893: result: -fPIC -DPIC configure:9901: checking if gcc PIC flag -fPIC -DPIC works configure:9919: gcc -c -g -O2 -fPIC -DPIC -DPIC conftest.c >&5 configure:9923: $? = 0 configure:9936: result: yes configure:9965: checking if gcc static flag -static works configure:9993: result: yes configure:10008: checking if gcc supports -c -o file.o configure:10029: gcc -c -g -O2 -o out/conftest2.o conftest.c >&5 configure:10033: $? = 0 configure:10055: result: yes configure:10063: checking if gcc supports -c -o file.o configure:10110: result: yes configure:10143: checking whether the gcc linker (/usr/bin/ld -m elf_x86_64) supports shared libraries configure:11402: result: yes configure:11439: checking whether -lc should be explicitly linked in configure:11447: gcc -c -g -O2 conftest.c >&5 configure:11450: $? = 0 configure:11465: gcc -shared -fPIC -DPIC conftest.o -v -Wl,-soname -Wl,conftest -o conftest 2\>\&1 \| /bin/grep -lc \>/dev/null 2\>\&1 configure:11468: $? = 0 configure:11482: result: no configure:11642: checking dynamic linker characteristics configure:12223: gcc -o conftest -g -O2 -Wl,-rpath -Wl,/foo conftest.c >&5 configure:12223: $? = 0 configure:12460: result: GNU/Linux ld.so configure:12582: checking how to hardcode library paths into programs configure:12607: result: immediate configure:13155: checking whether stripping libraries is possible configure:13160: result: yes configure:13195: checking if libtool supports shared libraries configure:13197: result: yes configure:13200: checking whether to build shared libraries configure:13225: result: yes configure:13228: checking whether to build static libraries configure:13232: result: no configure:13255: checking how to run the C++ preprocessor configure:13282: g++ -E conftest.cpp configure:13282: $? = 0 configure:13296: g++ -E conftest.cpp conftest.cpp:23:10: fatal error: ac_nonexistent.h: No such file or directory #include ^~~~~~~~~~~~~~~~~~ compilation terminated. configure:13296: $? = 1 configure: failed program was: | /* confdefs.h */ | #define PACKAGE_NAME "npstat" | #define PACKAGE_TARNAME "npstat" | #define PACKAGE_VERSION "5.3.0" | #define PACKAGE_STRING "npstat 5.3.0" | #define PACKAGE_BUGREPORT "" | #define PACKAGE_URL "" | #define PACKAGE "npstat" | #define VERSION "5.3.0" | #define STDC_HEADERS 1 | #define HAVE_SYS_TYPES_H 1 | #define HAVE_SYS_STAT_H 1 | #define HAVE_STDLIB_H 1 | #define HAVE_STRING_H 1 | #define HAVE_MEMORY_H 1 | #define HAVE_STRINGS_H 1 | #define HAVE_INTTYPES_H 1 | #define HAVE_STDINT_H 1 | #define HAVE_UNISTD_H 1 | #define HAVE_DLFCN_H 1 | #define LT_OBJDIR ".libs/" | /* end confdefs.h. */ | #include configure:13321: result: g++ -E configure:13341: g++ -E conftest.cpp configure:13341: $? = 0 configure:13355: g++ -E conftest.cpp conftest.cpp:23:10: fatal error: ac_nonexistent.h: No such file or directory #include ^~~~~~~~~~~~~~~~~~ compilation terminated. configure:13355: $? = 1 configure: failed program was: | /* confdefs.h */ | #define PACKAGE_NAME "npstat" | #define PACKAGE_TARNAME "npstat" | #define PACKAGE_VERSION "5.3.0" | #define PACKAGE_STRING "npstat 5.3.0" | #define PACKAGE_BUGREPORT "" | #define PACKAGE_URL "" | #define PACKAGE "npstat" | #define VERSION "5.3.0" | #define STDC_HEADERS 1 | #define HAVE_SYS_TYPES_H 1 | #define HAVE_SYS_STAT_H 1 | #define HAVE_STDLIB_H 1 | #define HAVE_STRING_H 1 | #define HAVE_MEMORY_H 1 | #define HAVE_STRINGS_H 1 | #define HAVE_INTTYPES_H 1 | #define HAVE_STDINT_H 1 | #define HAVE_UNISTD_H 1 | #define HAVE_DLFCN_H 1 | #define LT_OBJDIR ".libs/" | /* end confdefs.h. */ | #include configure:13517: checking for ld used by g++ configure:13584: result: /usr/bin/ld -m elf_x86_64 configure:13591: checking if the linker (/usr/bin/ld -m elf_x86_64) is GNU ld configure:13606: result: yes configure:13661: checking whether the g++ linker (/usr/bin/ld -m elf_x86_64) supports shared libraries configure:14734: result: yes configure:14770: g++ -c -std=c++11 -O3 -Wall -W -Werror conftest.cpp >&5 configure:14773: $? = 0 configure:15254: checking for g++ option to produce PIC configure:15261: result: -fPIC -DPIC configure:15269: checking if g++ PIC flag -fPIC -DPIC works configure:15287: g++ -c -std=c++11 -O3 -Wall -W -Werror -fPIC -DPIC -DPIC conftest.cpp >&5 configure:15291: $? = 0 configure:15304: result: yes configure:15327: checking if g++ static flag -static works configure:15355: result: yes configure:15367: checking if g++ supports -c -o file.o configure:15388: g++ -c -std=c++11 -O3 -Wall -W -Werror -o out/conftest2.o conftest.cpp >&5 configure:15392: $? = 0 configure:15414: result: yes configure:15419: checking if g++ supports -c -o file.o configure:15466: result: yes configure:15496: checking whether the g++ linker (/usr/bin/ld -m elf_x86_64) supports shared libraries configure:15536: result: yes configure:15677: checking dynamic linker characteristics configure:16422: result: GNU/Linux ld.so configure:16487: checking how to hardcode library paths into programs configure:16512: result: immediate configure:16653: checking if libtool supports shared libraries configure:16655: result: yes configure:16658: checking whether to build shared libraries configure:16682: result: yes configure:16685: checking whether to build static libraries configure:16689: result: no configure:17041: checking for g77 option to produce PIC configure:17048: result: -fPIC configure:17056: checking if g77 PIC flag -fPIC works configure:17074: g77 -c -g -O2 -fPIC conftest.f >&5 configure:17078: $? = 0 configure:17091: result: yes configure:17114: checking if g77 static flag -static works configure:17142: result: yes configure:17154: checking if g77 supports -c -o file.o configure:17175: g77 -c -g -O2 -o out/conftest2.o conftest.f >&5 configure:17179: $? = 0 configure:17201: result: yes configure:17206: checking if g77 supports -c -o file.o configure:17253: result: yes configure:17283: checking whether the g77 linker (/usr/bin/ld -m elf_x86_64) supports shared libraries configure:18492: result: yes configure:18633: checking dynamic linker characteristics configure:19372: result: GNU/Linux ld.so configure:19437: checking how to hardcode library paths into programs configure:19462: result: immediate configure:19662: checking that generated files are newer than configure configure:19668: result: done configure:19695: creating ./config.status ## ---------------------- ## ## Running config.status. ## ## ---------------------- ## This file was extended by npstat config.status 5.3.0, which was generated by GNU Autoconf 2.69. Invocation command line was CONFIG_FILES = CONFIG_HEADERS = CONFIG_LINKS = CONFIG_COMMANDS = $ ./config.status on dawn config.status:1143: creating Makefile config.status:1143: creating npstat/nm/Makefile config.status:1143: creating npstat/rng/Makefile config.status:1143: creating npstat/stat/Makefile config.status:1143: creating npstat/wrap/Makefile config.status:1143: creating npstat/interfaces/Makefile config.status:1143: creating npstat/emsunfold/Makefile config.status:1143: creating npstat/Makefile config.status:1143: creating examples/C++/Makefile config.status:1143: creating npstat/swig/Makefile config.status:1143: creating npstat.pc config.status:1315: executing depfiles commands config.status:1315: 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_CPP_set= ac_cv_env_CPP_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/7 -L/usr/lib/gcc/x86_64-linux-gnu/7/../../../x86_64-linux-gnu -L/usr/lib/gcc/x86_64-linux-gnu/7/../../../../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/7/../../.. -lgfortran -lm -lquadmath' ac_cv_header_dlfcn_h=yes ac_cv_header_inttypes_h=yes ac_cv_header_memory_h=yes ac_cv_header_stdc=yes ac_cv_header_stdint_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=/usr/bin/pkg-config ac_cv_path_install='/usr/bin/install -c' ac_cv_path_lt_DD=/bin/dd ac_cv_path_mkdir=/bin/mkdir ac_cv_prog_AWK=gawk ac_cv_prog_CPP='gcc -E' 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_c89= ac_cv_prog_cc_g=yes ac_cv_prog_cxx_g=yes 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=/usr/bin/ld lt_cv_path_LDCXX='/usr/bin/ld -m elf_x86_64' lt_cv_path_NM='/usr/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.15' 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.15' AWK='gawk' CC='gcc' CCDEPMODE='depmode=gcc3' CFLAGS='-g -O2' CPP='gcc -E' CPPFLAGS='' 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.3.0\" -DPACKAGE_STRING=\"npstat\ 5.3.0\" -DPACKAGE_BUGREPORT=\"\" -DPACKAGE_URL=\"\" -DPACKAGE=\"npstat\" -DVERSION=\"5.3.0\" -DSTDC_HEADERS=1 -DHAVE_SYS_TYPES_H=1 -DHAVE_SYS_STAT_H=1 -DHAVE_STDLIB_H=1 -DHAVE_STRING_H=1 -DHAVE_MEMORY_H=1 -DHAVE_STRINGS_H=1 -DHAVE_INTTYPES_H=1 -DHAVE_STDINT_H=1 -DHAVE_UNISTD_H=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' EXEEXT='' F77='g77' FFLAGS='-g -O2' FGREP='/bin/grep -F' FLIBS=' -L/usr/lib/gcc/x86_64-linux-gnu/7 -L/usr/lib/gcc/x86_64-linux-gnu/7/../../../x86_64-linux-gnu -L/usr/lib/gcc/x86_64-linux-gnu/7/../../../../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/7/../../.. -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='/usr/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='/usr/bin/nm -B' NMEDIT='' OBJDUMP='objdump' OBJEXT='o' OTOOL64='' OTOOL='' PACKAGE='npstat' PACKAGE_BUGREPORT='' PACKAGE_NAME='npstat' PACKAGE_STRING='npstat 5.3.0' PACKAGE_TARNAME='npstat' PACKAGE_URL='' PACKAGE_VERSION='5.3.0' PATH_SEPARATOR=':' PKG_CONFIG='/usr/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.3.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.3.0" #define PACKAGE_STRING "npstat 5.3.0" #define PACKAGE_BUGREPORT "" #define PACKAGE_URL "" #define PACKAGE "npstat" #define VERSION "5.3.0" #define STDC_HEADERS 1 #define HAVE_SYS_TYPES_H 1 #define HAVE_SYS_STAT_H 1 #define HAVE_STDLIB_H 1 #define HAVE_STRING_H 1 #define HAVE_MEMORY_H 1 #define HAVE_STRINGS_H 1 #define HAVE_INTTYPES_H 1 #define HAVE_STDINT_H 1 #define HAVE_UNISTD_H 1 #define HAVE_DLFCN_H 1 #define LT_OBJDIR ".libs/" configure: exit 0 Index: trunk/autom4te.cache/requests =================================================================== --- trunk/autom4te.cache/requests (revision 739) +++ trunk/autom4te.cache/requests (revision 740) @@ -1,739 +1,739 @@ # This file was generated by Autom4te Sun Aug 20 23:09:08 UTC 2017. # 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/autoconf/autoconf.m4f', '-', '/usr/share/aclocal-1.15/internal/ac-config-macro-dirs.m4', '/usr/share/aclocal/pkg.m4', '/usr/share/aclocal-1.15/amversion.m4', '/usr/share/aclocal-1.15/auxdir.m4', '/usr/share/aclocal-1.15/cond.m4', '/usr/share/aclocal-1.15/depend.m4', '/usr/share/aclocal-1.15/depout.m4', '/usr/share/aclocal-1.15/init.m4', '/usr/share/aclocal-1.15/install-sh.m4', '/usr/share/aclocal-1.15/lead-dot.m4', '/usr/share/aclocal-1.15/make.m4', '/usr/share/aclocal-1.15/missing.m4', '/usr/share/aclocal-1.15/options.m4', '/usr/share/aclocal-1.15/prog-cc-c-o.m4', '/usr/share/aclocal-1.15/runlog.m4', '/usr/share/aclocal-1.15/sanity.m4', '/usr/share/aclocal-1.15/silent.m4', '/usr/share/aclocal-1.15/strip.m4', '/usr/share/aclocal-1.15/substnot.m4', '/usr/share/aclocal-1.15/tar.m4', 'm4/libtool.m4', 'm4/ltoptions.m4', 'm4/ltsugar.m4', 'm4/ltversion.m4', 'm4/lt~obsolete.m4', 'configure.ac' ], { + 'AC_DEPLIBS_CHECK_METHOD' => 1, + '_LT_AC_PROG_CXXCPP' => 1, + 'LTSUGAR_VERSION' => 1, + '_LT_AC_TAGVAR' => 1, + 'LT_PATH_LD' => 1, + 'AC_PROG_EGREP' => 1, + 'LT_OUTPUT' => 1, 'AM_PROG_INSTALL_SH' => 1, - '_LT_AC_PROG_ECHO_BACKSLASH' => 1, - 'AC_LTDL_ENABLE_INSTALL' => 1, - 'AC_LIBTOOL_PROG_COMPILER_PIC' => 1, - 'AM_SANITY_CHECK' => 1, - 'LT_INIT' => 1, - 'm4_include' => 1, - 'LTOPTIONS_VERSION' => 1, - 'AC_LIBTOOL_FC' => 1, - '_LT_AC_CHECK_DLFCN' => 1, - 'AC_LIBTOOL_SYS_MAX_CMD_LEN' => 1, - 'AC_LIBTOOL_POSTDEP_PREDEP' => 1, - 'AC_ENABLE_STATIC' => 1, - '_AM_SET_OPTION' => 1, - 'LT_LANG' => 1, - 'AM_MAKE_INCLUDE' => 1, - '_LT_DLL_DEF_P' => 1, - 'AC_LIBTOOL_SYS_LIB_STRIP' => 1, - '_LT_PROG_F77' => 1, - '_LT_PROG_FC' => 1, - 'AC_PATH_TOOL_PREFIX' => 1, - 'AC_LIBTOOL_DLOPEN_SELF' => 1, - 'AC_PROG_LIBTOOL' => 1, + 'AC_LIBTOOL_LANG_C_CONFIG' => 1, + 'AM_ENABLE_SHARED' => 1, + '_AC_PROG_LIBTOOL' => 1, + 'LT_PATH_NM' => 1, + 'LT_PROG_RC' => 1, 'AC_LIBTOOL_LANG_RC_CONFIG' => 1, - '_m4_warn' => 1, - '_LT_PREPARE_SED_QUOTE_VARS' => 1, + '_LT_LINKER_BOILERPLATE' => 1, + 'LT_AC_PROG_EGREP' => 1, + 'AC_LTDL_OBJDIR' => 1, + 'AC_LIBTOOL_SYS_HARD_LINK_LOCKS' => 1, + '_LT_AC_LANG_F77' => 1, + '_AM_DEPENDENCIES' => 1, + 'AC_LIBTOOL_PROG_COMPILER_NO_RTTI' => 1, + 'AM_SET_CURRENT_AUTOMAKE_VERSION' => 1, + 'AC_LTDL_PREOPEN' => 1, + 'AM_PROG_NM' => 1, + 'LT_CMD_MAX_LEN' => 1, + 'AC_LIBTOOL_SETUP' => 1, + '_LT_AC_FILE_LTDLL_C' => 1, + 'AM_SUBST_NOTMAKE' => 1, + 'AM_MISSING_HAS_RUN' => 1, + 'AC_CONFIG_MACRO_DIR' => 1, + 'm4_pattern_allow' => 1, + 'LT_SUPPORTED_TAG' => 1, 'AC_LIBTOOL_PICMODE' => 1, - '_LT_CC_BASENAME' => 1, - 'AM_PROG_CC_C_O' => 1, - 'LT_SYS_DLOPEN_SELF' => 1, - 'AM_AUTOMAKE_VERSION' => 1, + 'AM_SET_LEADING_DOT' => 1, '_AM_CONFIG_MACRO_DIRS' => 1, - 'PKG_CHECK_VAR' => 1, - 'LT_PATH_LD' => 1, '_LT_AC_LANG_GCJ_CONFIG' => 1, - '_LT_AC_FILE_LTDLL_C' => 1, - 'AM_DEP_TRACK' => 1, - '_AM_PROG_CC_C_O' => 1, - 'AC_LIBTOOL_PROG_LD_HARDCODE_LIBPATH' => 1, - 'm4_pattern_forbid' => 1, - 'AM_AUX_DIR_EXPAND' => 1, - 'LT_PROG_GCJ' => 1, - '_LT_AC_TRY_DLOPEN_SELF' => 1, - 'AC_LIBTOOL_LANG_F77_CONFIG' => 1, - 'LT_OUTPUT' => 1, - '_LT_LINKER_OPTION' => 1, - '_LT_PROG_CXX' => 1, - 'AC_PATH_MAGIC' => 1, - 'AC_LIBTOOL_CXX' => 1, - '_LT_AC_PROG_CXXCPP' => 1, - 'LT_AC_PROG_GCJ' => 1, - 'AC_ENABLE_SHARED' => 1, - '_PKG_SHORT_ERRORS_SUPPORTED' => 1, - 'LT_AC_PROG_RC' => 1, - '_LT_AC_SYS_COMPILER' => 1, - 'LT_PROG_GO' => 1, - '_LT_PATH_TOOL_PREFIX' => 1, + '_LT_PROG_LTMAIN' => 1, + 'AC_LIBTOOL_POSTDEP_PREDEP' => 1, + 'AM_DISABLE_STATIC' => 1, + 'AM_DISABLE_SHARED' => 1, 'AC_DISABLE_STATIC' => 1, - 'LT_SUPPORTED_TAG' => 1, - 'LT_CMD_MAX_LEN' => 1, - '_LT_AC_LANG_CXX' => 1, - 'PKG_CHECK_EXISTS' => 1, - '_LT_WITH_SYSROOT' => 1, - 'AM_CONDITIONAL' => 1, - 'AC_DISABLE_FAST_INSTALL' => 1, - 'AC_LTDL_OBJDIR' => 1, - 'AC_PROG_EGREP' => 1, - '_LT_AC_LANG_CXX_CONFIG' => 1, '_LT_AC_SYS_LIBPATH_AIX' => 1, - '_AM_DEPENDENCIES' => 1, - '_LT_COMPILER_OPTION' => 1, - 'AM_DISABLE_SHARED' => 1, - '_AC_PROG_LIBTOOL' => 1, - 'PKG_PROG_PKG_CONFIG' => 1, - 'LT_AC_PROG_EGREP' => 1, + 'AC_LIBTOOL_F77' => 1, + 'AM_PROG_INSTALL_STRIP' => 1, + '_AM_MANGLE_OPTION' => 1, + 'AC_LIBTOOL_PROG_LD_SHLIBS' => 1, + 'AC_LIBTOOL_CONFIG' => 1, + 'AC_DISABLE_SHARED' => 1, '_LT_PROG_ECHO_BACKSLASH' => 1, - 'AC_DEFUN_ONCE' => 1, - '_LT_COMPILER_BOILERPLATE' => 1, - 'PKG_CHECK_MODULES_STATIC' => 1, + 'AM_OUTPUT_DEPENDENCY_COMMANDS' => 1, 'AC_CONFIG_MACRO_DIR_TRACE' => 1, - 'AM_RUN_LOG' => 1, - '_LT_REQUIRED_DARWIN_CHECKS' => 1, - 'AC_LIBTOOL_F77' => 1, - '_AM_SET_OPTIONS' => 1, - 'LT_PATH_NM' => 1, - 'AC_PROG_LD_RELOAD_FLAG' => 1, + 'AC_LIBTOOL_PROG_COMPILER_PIC' => 1, + '_LT_DLL_DEF_P' => 1, + 'AC_ENABLE_SHARED' => 1, + 'AC_LIBTOOL_SYS_DYNAMIC_LINKER' => 1, + '_AM_SET_OPTION' => 1, + 'AC_LIBTOOL_DLOPEN_SELF' => 1, + '_m4_warn' => 1, + '_PKG_SHORT_ERRORS_SUPPORTED' => 1, + 'LTOPTIONS_VERSION' => 1, + 'AU_DEFUN' => 1, + '_LT_PROG_F77' => 1, + 'LT_LANG' => 1, + 'AC_LIBTOOL_LANG_F77_CONFIG' => 1, + 'AC_PROG_LD' => 1, + 'AC_LIBTOOL_SYS_LIB_STRIP' => 1, + '_AM_PROG_CC_C_O' => 1, 'AC_LIBTOOL_SYS_OLD_ARCHIVE' => 1, - 'AM_SET_DEPDIR' => 1, - '_LT_AC_TAGCONFIG' => 1, + 'LT_PROG_GO' => 1, '_AM_PROG_TAR' => 1, - 'AM_OUTPUT_DEPENDENCY_COMMANDS' => 1, + '_LT_AC_LOCK' => 1, + '_LT_AC_TRY_DLOPEN_SELF' => 1, 'AC_LIBTOOL_LANG_GCJ_CONFIG' => 1, - '_LT_LINKER_BOILERPLATE' => 1, - 'AC_CHECK_LIBM' => 1, - '_AM_AUTOCONF_VERSION' => 1, - 'AC_LIBTOOL_LANG_CXX_CONFIG' => 1, - 'AC_ENABLE_FAST_INSTALL' => 1, - 'AM_MISSING_HAS_RUN' => 1, - 'LT_PROG_RC' => 1, - 'PKG_INSTALLDIR' => 1, - '_AM_OUTPUT_DEPENDENCY_COMMANDS' => 1, - 'AM_ENABLE_SHARED' => 1, - '_AC_AM_CONFIG_HEADER_HOOK' => 1, - '_LT_AC_LANG_C_CONFIG' => 1, - 'AM_SET_LEADING_DOT' => 1, - 'AC_LIBTOOL_RC' => 1, - '_LT_AC_LANG_F77' => 1, + 'AM_MAKE_INCLUDE' => 1, + 'AC_PATH_TOOL_PREFIX' => 1, + 'LT_PROG_GCJ' => 1, + 'AC_PROG_LD_RELOAD_FLAG' => 1, + 'AC_PROG_LD_GNU' => 1, 'AC_DEFUN' => 1, - 'PKG_CHECK_MODULES' => 1, - 'AC_LIBTOOL_SYS_GLOBAL_SYMBOL_PIPE' => 1, - 'AC_LIBTOOL_PROG_LD_SHLIBS' => 1, - 'LT_AC_PROG_SED' => 1, + '_LT_PREPARE_SED_QUOTE_VARS' => 1, + 'LT_SYS_DLOPEN_SELF' => 1, 'AM_PROG_LD' => 1, + '_AM_SET_OPTIONS' => 1, + '_LT_PATH_TOOL_PREFIX' => 1, + 'm4_include' => 1, + 'AM_MISSING_PROG' => 1, + '_LT_PROG_CXX' => 1, + 'PKG_PROG_PKG_CONFIG' => 1, + '_LT_AC_SYS_COMPILER' => 1, + 'AM_SANITY_CHECK' => 1, + 'LTVERSION_VERSION' => 1, + '_LT_REQUIRED_DARWIN_CHECKS' => 1, + 'PKG_CHECK_EXISTS' => 1, + 'PKG_INSTALLDIR' => 1, + 'LT_AC_PROG_SED' => 1, + 'PKG_CHECK_MODULES_STATIC' => 1, + 'AC_LIBTOOL_COMPILER_OPTION' => 1, + 'AM_SET_DEPDIR' => 1, + 'AM_RUN_LOG' => 1, + 'AC_LIBTOOL_SYS_GLOBAL_SYMBOL_PIPE' => 1, + 'AM_SILENT_RULES' => 1, + '_LT_LINKER_OPTION' => 1, + '_LT_AC_PROG_ECHO_BACKSLASH' => 1, + 'LT_LIB_M' => 1, + 'AC_LIBTOOL_PROG_CC_C_O' => 1, + '_AC_AM_CONFIG_HEADER_HOOK' => 1, + 'LT_AC_PROG_GCJ' => 1, 'AC_LIBTOOL_GCJ' => 1, - 'AC_LIBTOOL_LANG_C_CONFIG' => 1, + 'AC_PROG_NM' => 1, + 'include' => 1, + '_LT_AC_LANG_F77_CONFIG' => 1, + 'AC_PATH_MAGIC' => 1, + 'AC_ENABLE_FAST_INSTALL' => 1, + 'AC_LIBTOOL_FC' => 1, + 'AC_LIBTOOL_RC' => 1, + 'AC_LTDL_ENABLE_INSTALL' => 1, + 'AM_DEP_TRACK' => 1, + 'AM_PROG_LIBTOOL' => 1, + '_LT_WITH_SYSROOT' => 1, + '_LT_CC_BASENAME' => 1, + 'AC_LIBTOOL_CXX' => 1, + 'LT_INIT' => 1, + '_LT_AC_LANG_GCJ' => 1, + 'AM_INIT_AUTOMAKE' => 1, + 'AM_CONDITIONAL' => 1, + '_AM_AUTOCONF_VERSION' => 1, '_LT_AC_LANG_RC_CONFIG' => 1, - 'LT_LIB_M' => 1, + 'AM_AUTOMAKE_VERSION' => 1, + 'AM_AUX_DIR_EXPAND' => 1, + '_LT_COMPILER_BOILERPLATE' => 1, + '_AM_IF_OPTION' => 1, + 'PKG_CHECK_MODULES' => 1, + '_LT_COMPILER_OPTION' => 1, + 'AC_PROG_LIBTOOL' => 1, + '_LT_AC_LANG_CXX' => 1, 'AC_LIBTOOL_OBJDIR' => 1, - '_LT_AC_LANG_F77_CONFIG' => 1, - 'AC_LIBTOOL_SYS_DYNAMIC_LINKER' => 1, - 'AC_LIBTOOL_SETUP' => 1, - 'AC_LIBTOOL_COMPILER_OPTION' => 1, - 'AC_LIBTOOL_LINKER_OPTION' => 1, - 'AM_SUBST_NOTMAKE' => 1, - '_LT_PROG_LTMAIN' => 1, - 'AM_DISABLE_STATIC' => 1, - 'AC_LIBTOOL_SYS_HARD_LINK_LOCKS' => 1, - 'include' => 1, - 'm4_pattern_allow' => 1, - 'AM_MISSING_PROG' => 1, - '_AM_SUBST_NOTMAKE' => 1, - 'AM_PROG_NM' => 1, 'AC_LIBTOOL_DLOPEN' => 1, - 'AC_PROG_LD_GNU' => 1, - '_AM_IF_OPTION' => 1, + '_LT_PROG_FC' => 1, 'AC_LIBTOOL_WIN32_DLL' => 1, - 'AC_LTDL_PREOPEN' => 1, - 'AU_DEFUN' => 1, - '_AM_MANGLE_OPTION' => 1, - 'AC_CONFIG_MACRO_DIR' => 1, + 'AC_LIBTOOL_LANG_CXX_CONFIG' => 1, + '_LT_AC_CHECK_DLFCN' => 1, + 'AM_ENABLE_STATIC' => 1, + '_AM_SUBST_NOTMAKE' => 1, + '_LT_AC_LANG_CXX_CONFIG' => 1, 'LTOBSOLETE_VERSION' => 1, - 'LTVERSION_VERSION' => 1, - 'AC_DEPLIBS_CHECK_METHOD' => 1, - '_LT_AC_TAGVAR' => 1, - 'AM_INIT_AUTOMAKE' => 1, - 'AC_LIBTOOL_PROG_CC_C_O' => 1, - 'AM_SILENT_RULES' => 1, + 'AC_DEFUN_ONCE' => 1, + '_LT_AC_TAGCONFIG' => 1, + '_LT_AC_LANG_C_CONFIG' => 1, + 'LT_AC_PROG_RC' => 1, + 'AC_LIBTOOL_PROG_LD_HARDCODE_LIBPATH' => 1, '_LT_AC_SHELL_INIT' => 1, - 'AC_PROG_LD' => 1, - 'AM_PROG_LIBTOOL' => 1, - 'AC_LIBTOOL_PROG_COMPILER_NO_RTTI' => 1, - 'AC_LIBTOOL_CONFIG' => 1, - '_LT_AC_LOCK' => 1, + '_AM_OUTPUT_DEPENDENCY_COMMANDS' => 1, + 'AC_CHECK_LIBM' => 1, + 'AC_ENABLE_STATIC' => 1, + 'AC_LIBTOOL_SYS_MAX_CMD_LEN' => 1, + 'AC_LIBTOOL_LINKER_OPTION' => 1, + 'm4_pattern_forbid' => 1, + 'AM_PROG_CC_C_O' => 1, + 'PKG_CHECK_VAR' => 1, 'PKG_NOARCH_INSTALLDIR' => 1, - 'LTSUGAR_VERSION' => 1, - 'AM_PROG_INSTALL_STRIP' => 1, - 'AM_SET_CURRENT_AUTOMAKE_VERSION' => 1, - '_LT_AC_LANG_GCJ' => 1, - 'AC_PROG_NM' => 1, - 'AC_DISABLE_SHARED' => 1, - 'AM_ENABLE_STATIC' => 1 + 'AC_DISABLE_FAST_INSTALL' => 1 } ], 'Autom4te::Request' ), bless( [ '1', 1, [ '/usr/share/autoconf' ], [ '/usr/share/autoconf/autoconf/autoconf.m4f', 'aclocal.m4', 'configure.ac' ], { - 'm4_pattern_allow' => 1, + 'AM_EXTRA_RECURSIVE_TARGETS' => 1, + 'AM_PROG_CXX_C_O' => 1, + 'AC_FC_FREEFORM' => 1, + 'AC_DEFINE_TRACE_LITERAL' => 1, 'AC_SUBST' => 1, - 'AM_PROG_FC_C_O' => 1, + 'AM_GNU_GETTEXT' => 1, + 'AC_CONFIG_HEADERS' => 1, + 'include' => 1, + '_AM_COND_IF' => 1, + 'AM_PROG_CC_C_O' => 1, + 'AC_CANONICAL_SYSTEM' => 1, + 'm4_pattern_forbid' => 1, + 'AM_SILENT_RULES' => 1, 'AM_MAKEFILE_INCLUDE' => 1, - 'm4_sinclude' => 1, + 'AC_CONFIG_SUBDIRS' => 1, + 'AH_OUTPUT' => 1, + 'AM_PROG_AR' => 1, + 'AM_PROG_F77_C_O' => 1, + '_m4_warn' => 1, + 'AC_CANONICAL_TARGET' => 1, + 'AC_PROG_LIBTOOL' => 1, + 'LT_SUPPORTED_TAG' => 1, '_LT_AC_TAGCONFIG' => 1, - 'include' => 1, - 'AM_PROG_CXX_C_O' => 1, + 'AM_PROG_FC_C_O' => 1, + 'AC_FC_SRCEXT' => 1, + 'm4_pattern_allow' => 1, + 'AC_CONFIG_LINKS' => 1, + 'AC_CANONICAL_HOST' => 1, '_AM_SUBST_NOTMAKE' => 1, - 'LT_INIT' => 1, - 'm4_include' => 1, - 'AM_PROG_F77_C_O' => 1, + 'AC_CANONICAL_BUILD' => 1, + 'AC_CONFIG_LIBOBJ_DIR' => 1, + 'AC_REQUIRE_AUX_FILE' => 1, + 'AM_PATH_GUILE' => 1, + '_AM_COND_ELSE' => 1, + 'AM_AUTOMAKE_VERSION' => 1, + 'm4_sinclude' => 1, + 'AM_NLS' => 1, + 'LT_CONFIG_LTDL_DIR' => 1, + '_AM_MAKEFILE_INCLUDE' => 1, + 'sinclude' => 1, 'AC_INIT' => 1, + 'AM_GNU_GETTEXT_INTL_SUBDIR' => 1, + 'AC_CONFIG_AUX_DIR' => 1, 'AC_SUBST_TRACE' => 1, + 'AC_CONFIG_FILES' => 1, + 'AM_PROG_MKDIR_P' => 1, + 'AC_LIBSOURCE' => 1, '_AM_COND_ENDIF' => 1, - 'AH_OUTPUT' => 1, - 'AC_CONFIG_AUX_DIR' => 1, - 'AM_POT_TOOLS' => 1, + 'AM_PROG_MOC' => 1, + 'AM_PROG_LIBTOOL' => 1, + 'AC_FC_PP_SRCEXT' => 1, + 'AM_XGETTEXT_OPTION' => 1, 'AM_CONDITIONAL' => 1, - 'AM_PATH_GUILE' => 1, - 'AC_CONFIG_FILES' => 1, - 'LT_SUPPORTED_TAG' => 1, - 'AM_GNU_GETTEXT' => 1, 'AC_FC_PP_DEFINE' => 1, - 'AC_CONFIG_HEADERS' => 1, 'AM_INIT_AUTOMAKE' => 1, - 'AC_REQUIRE_AUX_FILE' => 1, - 'AC_LIBSOURCE' => 1, + 'AM_POT_TOOLS' => 1, 'AM_ENABLE_MULTILIB' => 1, - 'AC_DEFINE_TRACE_LITERAL' => 1, - 'AC_CONFIG_SUBDIRS' => 1, - 'AC_CANONICAL_TARGET' => 1, - 'AC_CANONICAL_HOST' => 1, - '_AM_MAKEFILE_INCLUDE' => 1, - 'AM_XGETTEXT_OPTION' => 1, - 'AC_FC_PP_SRCEXT' => 1, - 'AM_EXTRA_RECURSIVE_TARGETS' => 1, - 'AM_SILENT_RULES' => 1, - 'sinclude' => 1, - 'AC_PROG_LIBTOOL' => 1, - 'LT_CONFIG_LTDL_DIR' => 1, - '_m4_warn' => 1, - 'AC_FC_FREEFORM' => 1, - 'AM_AUTOMAKE_VERSION' => 1, - 'AM_PROG_LIBTOOL' => 1, - 'AM_PROG_AR' => 1, - 'AM_PROG_CC_C_O' => 1, - 'AM_GNU_GETTEXT_INTL_SUBDIR' => 1, - 'AC_FC_SRCEXT' => 1, - 'AM_NLS' => 1, - 'AC_CANONICAL_BUILD' => 1, - '_AM_COND_ELSE' => 1, + 'LT_INIT' => 1, 'AM_MAINTAINER_MODE' => 1, - 'AM_PROG_MKDIR_P' => 1, - 'm4_pattern_forbid' => 1, - 'AM_PROG_MOC' => 1, - '_AM_COND_IF' => 1, - 'AC_CONFIG_LINKS' => 1, - 'AC_CANONICAL_SYSTEM' => 1, - 'AC_CONFIG_LIBOBJ_DIR' => 1 + 'm4_include' => 1 } ], 'Autom4te::Request' ), bless( [ '2', 1, [ '/usr/share/autoconf' ], [ '/usr/share/autoconf/autoconf/autoconf.m4f', '-', '/usr/share/aclocal-1.15/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.15/amversion.m4', '/usr/share/aclocal-1.15/auxdir.m4', '/usr/share/aclocal-1.15/cond.m4', '/usr/share/aclocal-1.15/depend.m4', '/usr/share/aclocal-1.15/depout.m4', '/usr/share/aclocal-1.15/init.m4', '/usr/share/aclocal-1.15/install-sh.m4', '/usr/share/aclocal-1.15/lead-dot.m4', '/usr/share/aclocal-1.15/make.m4', '/usr/share/aclocal-1.15/missing.m4', '/usr/share/aclocal-1.15/options.m4', '/usr/share/aclocal-1.15/prog-cc-c-o.m4', '/usr/share/aclocal-1.15/runlog.m4', '/usr/share/aclocal-1.15/sanity.m4', '/usr/share/aclocal-1.15/silent.m4', '/usr/share/aclocal-1.15/strip.m4', '/usr/share/aclocal-1.15/substnot.m4', '/usr/share/aclocal-1.15/tar.m4', 'm4/libtool.m4', 'm4/ltoptions.m4', 'm4/ltsugar.m4', 'm4/ltversion.m4', 'm4/lt~obsolete.m4', 'configure.ac' ], { + '_AM_SET_OPTION' => 1, + 'AC_LIBTOOL_SYS_DYNAMIC_LINKER' => 1, + 'AC_LIBTOOL_DLOPEN_SELF' => 1, + 'AM_OUTPUT_DEPENDENCY_COMMANDS' => 1, + '_LT_PROG_ECHO_BACKSLASH' => 1, + 'AC_CONFIG_MACRO_DIR_TRACE' => 1, + '_LT_DLL_DEF_P' => 1, 'AC_LIBTOOL_PROG_COMPILER_PIC' => 1, - 'LT_SYS_MODULE_PATH' => 1, - 'AC_LTDL_ENABLE_INSTALL' => 1, - 'LTOPTIONS_VERSION' => 1, - 'LT_INIT' => 1, - 'm4_include' => 1, - 'AM_SANITY_CHECK' => 1, - '_LT_AC_PROG_ECHO_BACKSLASH' => 1, - 'AM_PROG_INSTALL_SH' => 1, + 'LTDL_CONVENIENCE' => 1, + 'AC_ENABLE_SHARED' => 1, + 'AC_LTDL_SYMBOL_USCORE' => 1, + 'LT_LIB_DLLOAD' => 1, + '_LT_AC_LOCK' => 1, + '_AM_PROG_CC_C_O' => 1, + 'AC_LIBTOOL_SYS_OLD_ARCHIVE' => 1, + 'LT_PROG_GO' => 1, + '_AM_PROG_TAR' => 1, + 'AC_LIBTOOL_LANG_GCJ_CONFIG' => 1, + 'AM_MAKE_INCLUDE' => 1, 'AC_PATH_TOOL_PREFIX' => 1, + '_LT_AC_TRY_DLOPEN_SELF' => 1, + 'AC_PROG_LD_GNU' => 1, + 'AC_DEFUN' => 1, + 'LT_PROG_GCJ' => 1, + 'AC_PROG_LD_RELOAD_FLAG' => 1, + '_LT_PREPARE_SED_QUOTE_VARS' => 1, + '_PKG_SHORT_ERRORS_SUPPORTED' => 1, + 'LTOPTIONS_VERSION' => 1, + '_m4_warn' => 1, '_LT_PROG_F77' => 1, - '_LT_PROG_FC' => 1, - 'AC_ENABLE_STATIC' => 1, - 'AC_LIBTOOL_POSTDEP_PREDEP' => 1, - '_LT_AC_CHECK_DLFCN' => 1, - 'AC_LIBTOOL_SYS_MAX_CMD_LEN' => 1, - 'AC_LIBTOOL_FC' => 1, - 'AC_LIBTOOL_SYS_LIB_STRIP' => 1, - '_LT_DLL_DEF_P' => 1, + 'AU_DEFUN' => 1, + 'AC_PROG_LD' => 1, + 'AC_LIBTOOL_LANG_F77_CONFIG' => 1, + 'AC_WITH_LTDL' => 1, 'LT_LANG' => 1, - 'AM_MAKE_INCLUDE' => 1, - '_AM_SET_OPTION' => 1, - 'AM_PROG_CC_C_O' => 1, - '_AM_CONFIG_MACRO_DIRS' => 1, - 'PKG_CHECK_VAR' => 1, - 'AM_AUTOMAKE_VERSION' => 1, - 'LT_SYS_DLOPEN_SELF' => 1, - '_m4_warn' => 1, - '_LT_PREPARE_SED_QUOTE_VARS' => 1, + 'AC_LIBTOOL_SYS_LIB_STRIP' => 1, + '_LTDL_SETUP' => 1, + 'AC_LTDL_OBJDIR' => 1, + 'LT_AC_PROG_EGREP' => 1, + '_LT_LINKER_BOILERPLATE' => 1, 'AC_LIBTOOL_LANG_RC_CONFIG' => 1, - 'AC_PROG_LIBTOOL' => 1, - 'AC_LIBTOOL_DLOPEN_SELF' => 1, - '_LT_CC_BASENAME' => 1, - 'AC_LIBTOOL_PICMODE' => 1, - 'm4_pattern_forbid' => 1, - 'AM_AUX_DIR_EXPAND' => 1, + 'LT_PROG_RC' => 1, + 'LT_SYS_DLOPEN_DEPLIBS' => 1, + '_LT_AC_LANG_F77' => 1, + 'LT_CONFIG_LTDL_DIR' => 1, + 'AC_LIBTOOL_SYS_HARD_LINK_LOCKS' => 1, + 'AM_SET_CURRENT_AUTOMAKE_VERSION' => 1, + 'AC_LIBTOOL_PROG_COMPILER_NO_RTTI' => 1, + '_AM_DEPENDENCIES' => 1, + 'AC_LTDL_PREOPEN' => 1, + 'LTDL_INIT' => 1, + '_LT_AC_PROG_CXXCPP' => 1, + 'AC_DEPLIBS_CHECK_METHOD' => 1, + '_LT_AC_TAGVAR' => 1, + 'LT_PATH_LD' => 1, + 'LTSUGAR_VERSION' => 1, + 'AC_PROG_EGREP' => 1, + '_AC_PROG_LIBTOOL' => 1, + 'AM_ENABLE_SHARED' => 1, + 'LT_PATH_NM' => 1, + 'AM_PROG_INSTALL_SH' => 1, + 'AC_LIBTOOL_LANG_C_CONFIG' => 1, 'LT_OUTPUT' => 1, - 'AC_LIBTOOL_LANG_F77_CONFIG' => 1, - '_LT_AC_TRY_DLOPEN_SELF' => 1, - 'LT_PROG_GCJ' => 1, - 'AC_LTDL_SYMBOL_USCORE' => 1, + '_AM_CONFIG_MACRO_DIRS' => 1, + 'AM_SET_LEADING_DOT' => 1, + 'AM_DISABLE_STATIC' => 1, + 'AM_DISABLE_SHARED' => 1, + 'AC_LIBTOOL_POSTDEP_PREDEP' => 1, + '_LT_PROG_LTMAIN' => 1, '_LT_AC_LANG_GCJ_CONFIG' => 1, - 'LT_PATH_LD' => 1, - 'LT_LIB_DLLOAD' => 1, - '_AM_PROG_CC_C_O' => 1, - 'AC_LIBTOOL_PROG_LD_HARDCODE_LIBPATH' => 1, + 'AM_PROG_INSTALL_STRIP' => 1, + '_LT_AC_SYS_LIBPATH_AIX' => 1, + 'AC_DISABLE_STATIC' => 1, + 'AC_LIBTOOL_F77' => 1, + 'AC_DISABLE_SHARED' => 1, + 'AC_LIBTOOL_CONFIG' => 1, + 'AC_LIBTOOL_PROG_LD_SHLIBS' => 1, + '_AM_MANGLE_OPTION' => 1, '_LT_AC_FILE_LTDLL_C' => 1, - 'AM_DEP_TRACK' => 1, - '_PKG_SHORT_ERRORS_SUPPORTED' => 1, - 'LT_AC_PROG_RC' => 1, - 'AC_ENABLE_SHARED' => 1, - 'LT_AC_PROG_GCJ' => 1, - 'LT_SYS_SYMBOL_USCORE' => 1, + 'AC_LIBTOOL_SETUP' => 1, + 'LT_CMD_MAX_LEN' => 1, + 'LT_WITH_LTDL' => 1, + 'AM_PROG_NM' => 1, + 'AM_MISSING_HAS_RUN' => 1, + 'AM_SUBST_NOTMAKE' => 1, 'AC_LTDL_SYS_DLOPEN_DEPLIBS' => 1, - '_LT_AC_SYS_COMPILER' => 1, - 'LT_PROG_GO' => 1, - 'AC_PATH_MAGIC' => 1, - '_LT_PROG_CXX' => 1, - '_LT_LINKER_OPTION' => 1, - '_LT_AC_PROG_CXXCPP' => 1, - 'AC_LIBTOOL_CXX' => 1, - 'AC_DISABLE_FAST_INSTALL' => 1, 'LT_FUNC_ARGZ' => 1, - 'LT_SYS_DLOPEN_DEPLIBS' => 1, - 'AC_LTDL_OBJDIR' => 1, - 'AC_DISABLE_STATIC' => 1, - 'LT_CMD_MAX_LEN' => 1, + 'AC_CONFIG_MACRO_DIR' => 1, + 'AC_LIBTOOL_PICMODE' => 1, 'LT_SUPPORTED_TAG' => 1, - '_LT_PATH_TOOL_PREFIX' => 1, - 'AM_CONDITIONAL' => 1, + 'm4_pattern_allow' => 1, + '_AM_AUTOCONF_VERSION' => 1, + 'AM_AUTOMAKE_VERSION' => 1, + 'LTDL_INSTALLABLE' => 1, + '_LT_AC_LANG_RC_CONFIG' => 1, + '_LT_LIBOBJ' => 1, + 'AM_AUX_DIR_EXPAND' => 1, + '_LT_COMPILER_BOILERPLATE' => 1, + '_AM_IF_OPTION' => 1, + 'AM_PROG_LIBTOOL' => 1, + 'LT_FUNC_DLSYM_USCORE' => 1, + 'AC_LIBTOOL_CXX' => 1, + 'LT_SYS_DLSEARCH_PATH' => 1, + '_LT_CC_BASENAME' => 1, '_LT_WITH_SYSROOT' => 1, - 'LTDL_INIT' => 1, - 'PKG_CHECK_EXISTS' => 1, + 'LT_INIT' => 1, + 'AC_LTDL_SHLIBEXT' => 1, + 'AM_CONDITIONAL' => 1, + 'AC_LTDL_SYSSEARCHPATH' => 1, + 'AM_INIT_AUTOMAKE' => 1, + '_LT_AC_LANG_GCJ' => 1, + 'AC_LIBTOOL_PROG_LD_HARDCODE_LIBPATH' => 1, + '_LT_AC_LANG_C_CONFIG' => 1, + 'LT_AC_PROG_RC' => 1, + 'LT_SYS_MODULE_EXT' => 1, + 'AC_CHECK_LIBM' => 1, + '_AM_OUTPUT_DEPENDENCY_COMMANDS' => 1, + '_LT_AC_SHELL_INIT' => 1, + 'm4_pattern_forbid' => 1, + 'AM_PROG_CC_C_O' => 1, + 'AC_LTDL_SHLIBPATH' => 1, + 'AC_LIBTOOL_LINKER_OPTION' => 1, + 'AC_LIBTOOL_SYS_MAX_CMD_LEN' => 1, + 'AC_ENABLE_STATIC' => 1, + 'AC_DISABLE_FAST_INSTALL' => 1, + 'PKG_NOARCH_INSTALLDIR' => 1, + 'LT_SYS_MODULE_PATH' => 1, + 'PKG_CHECK_VAR' => 1, + 'AC_LIBTOOL_OBJDIR' => 1, '_LT_AC_LANG_CXX' => 1, - 'PKG_PROG_PKG_CONFIG' => 1, - 'LT_AC_PROG_EGREP' => 1, - '_LT_PROG_ECHO_BACKSLASH' => 1, - '_AC_PROG_LIBTOOL' => 1, - 'AM_DISABLE_SHARED' => 1, - '_LT_COMPILER_BOILERPLATE' => 1, - 'PKG_CHECK_MODULES_STATIC' => 1, - 'AC_DEFUN_ONCE' => 1, - 'AC_LIB_LTDL' => 1, - 'AC_PROG_EGREP' => 1, '_LT_COMPILER_OPTION' => 1, - '_AM_DEPENDENCIES' => 1, + 'AC_PROG_LIBTOOL' => 1, + 'PKG_CHECK_MODULES' => 1, + '_LT_PROG_FC' => 1, + 'AC_LIBTOOL_DLOPEN' => 1, '_LT_AC_LANG_CXX_CONFIG' => 1, - '_LT_AC_SYS_LIBPATH_AIX' => 1, - 'AC_LTDL_SHLIBPATH' => 1, + '_AM_SUBST_NOTMAKE' => 1, + '_LT_AC_CHECK_DLFCN' => 1, + 'AM_ENABLE_STATIC' => 1, + 'AC_LIBTOOL_LANG_CXX_CONFIG' => 1, 'AC_LIBLTDL_CONVENIENCE' => 1, - '_AM_SET_OPTIONS' => 1, - 'AC_PROG_LD_RELOAD_FLAG' => 1, - 'LT_PATH_NM' => 1, - '_LT_REQUIRED_DARWIN_CHECKS' => 1, - 'AM_RUN_LOG' => 1, - 'AC_CONFIG_MACRO_DIR_TRACE' => 1, - 'AC_LIBTOOL_F77' => 1, - 'AC_LTDL_SHLIBEXT' => 1, - 'AM_OUTPUT_DEPENDENCY_COMMANDS' => 1, - '_LT_LINKER_BOILERPLATE' => 1, - 'AC_LIBTOOL_LANG_GCJ_CONFIG' => 1, + 'AC_LIBTOOL_WIN32_DLL' => 1, '_LT_AC_TAGCONFIG' => 1, - 'AM_SET_DEPDIR' => 1, - 'AC_LIBTOOL_SYS_OLD_ARCHIVE' => 1, - '_AM_PROG_TAR' => 1, - 'AM_MISSING_HAS_RUN' => 1, - 'LT_PROG_RC' => 1, - 'AM_ENABLE_SHARED' => 1, - '_AM_OUTPUT_DEPENDENCY_COMMANDS' => 1, - 'LT_FUNC_DLSYM_USCORE' => 1, + 'LTOBSOLETE_VERSION' => 1, + 'AC_DEFUN_ONCE' => 1, 'PKG_INSTALLDIR' => 1, - 'AC_LIBTOOL_LANG_CXX_CONFIG' => 1, - '_AM_AUTOCONF_VERSION' => 1, - 'AC_CHECK_LIBM' => 1, - 'AC_ENABLE_FAST_INSTALL' => 1, - 'AC_LIBTOOL_SYS_GLOBAL_SYMBOL_PIPE' => 1, + 'PKG_CHECK_EXISTS' => 1, + 'AC_LIBTOOL_COMPILER_OPTION' => 1, + 'AM_SET_DEPDIR' => 1, + 'PKG_CHECK_MODULES_STATIC' => 1, 'LT_AC_PROG_SED' => 1, - 'AC_LIBTOOL_PROG_LD_SHLIBS' => 1, - 'PKG_CHECK_MODULES' => 1, - 'AC_WITH_LTDL' => 1, + 'AC_LIB_LTDL' => 1, + 'AM_RUN_LOG' => 1, + 'AC_LTDL_DLLIB' => 1, + '_LT_PATH_TOOL_PREFIX' => 1, + '_AM_SET_OPTIONS' => 1, 'AM_PROG_LD' => 1, - 'AM_SET_LEADING_DOT' => 1, - '_LT_AC_LANG_C_CONFIG' => 1, - '_AC_AM_CONFIG_HEADER_HOOK' => 1, - 'AC_DEFUN' => 1, - '_LT_AC_LANG_F77' => 1, - '_LTDL_SETUP' => 1, - 'AC_LIBTOOL_RC' => 1, - '_LT_PROG_LTMAIN' => 1, - 'AM_DISABLE_STATIC' => 1, - 'AC_LIBTOOL_LANG_C_CONFIG' => 1, - '_LT_AC_LANG_RC_CONFIG' => 1, - 'AC_LIBTOOL_GCJ' => 1, - 'AC_LIBTOOL_LINKER_OPTION' => 1, - 'AM_SUBST_NOTMAKE' => 1, - 'AC_LIBTOOL_SETUP' => 1, - 'AC_LIBTOOL_SYS_DYNAMIC_LINKER' => 1, - 'AC_LIBTOOL_COMPILER_OPTION' => 1, - 'AC_LIBTOOL_OBJDIR' => 1, - '_LT_AC_LANG_F77_CONFIG' => 1, - 'LT_LIB_M' => 1, + 'LT_SYS_DLOPEN_SELF' => 1, + 'PKG_PROG_PKG_CONFIG' => 1, + '_LT_PROG_CXX' => 1, + 'LT_SYS_SYMBOL_USCORE' => 1, 'AM_MISSING_PROG' => 1, - 'AM_PROG_NM' => 1, - '_AM_SUBST_NOTMAKE' => 1, - '_LT_LIBOBJ' => 1, - 'include' => 1, - 'AC_LIBTOOL_SYS_HARD_LINK_LOCKS' => 1, - 'm4_pattern_allow' => 1, + 'm4_include' => 1, + 'AM_SANITY_CHECK' => 1, + 'AC_LTDL_DLSYM_USCORE' => 1, 'LTVERSION_VERSION' => 1, - 'AC_CONFIG_MACRO_DIR' => 1, - 'LTOBSOLETE_VERSION' => 1, - 'AC_LIBTOOL_PROG_CC_C_O' => 1, - 'AM_INIT_AUTOMAKE' => 1, - 'AC_DEPLIBS_CHECK_METHOD' => 1, - '_LT_AC_TAGVAR' => 1, - 'AC_LTDL_PREOPEN' => 1, - 'AC_LIBTOOL_WIN32_DLL' => 1, - '_AM_IF_OPTION' => 1, - 'AC_LIBTOOL_DLOPEN' => 1, - 'AC_PROG_LD_GNU' => 1, - 'LTDL_INSTALLABLE' => 1, - '_AM_MANGLE_OPTION' => 1, - 'AU_DEFUN' => 1, - 'LT_WITH_LTDL' => 1, - 'AC_LIBTOOL_PROG_COMPILER_NO_RTTI' => 1, - 'AC_PROG_LD' => 1, - 'AM_PROG_LIBTOOL' => 1, + '_LT_REQUIRED_DARWIN_CHECKS' => 1, + '_LT_AC_SYS_COMPILER' => 1, + '_LT_AC_LANG_F77_CONFIG' => 1, + 'include' => 1, + 'AC_PROG_NM' => 1, + '_AC_AM_CONFIG_HEADER_HOOK' => 1, + 'LT_AC_PROG_GCJ' => 1, + 'AC_LIBTOOL_GCJ' => 1, + 'AC_PATH_MAGIC' => 1, + 'AC_LTDL_ENABLE_INSTALL' => 1, + 'AC_LIBTOOL_RC' => 1, + 'AC_LIBTOOL_FC' => 1, 'AC_LIBLTDL_INSTALLABLE' => 1, - 'LT_CONFIG_LTDL_DIR' => 1, + 'AC_ENABLE_FAST_INSTALL' => 1, + 'AM_DEP_TRACK' => 1, 'AM_SILENT_RULES' => 1, - 'LT_SYS_DLSEARCH_PATH' => 1, - '_LT_AC_SHELL_INIT' => 1, - 'LT_SYS_MODULE_EXT' => 1, - 'AC_PROG_NM' => 1, - 'AM_ENABLE_STATIC' => 1, - 'LTDL_CONVENIENCE' => 1, - 'AC_DISABLE_SHARED' => 1, - 'LTSUGAR_VERSION' => 1, - 'PKG_NOARCH_INSTALLDIR' => 1, - 'AC_LTDL_DLLIB' => 1, - 'AC_LIBTOOL_CONFIG' => 1, - '_LT_AC_LOCK' => 1, - 'AM_SET_CURRENT_AUTOMAKE_VERSION' => 1, - 'AC_LTDL_DLSYM_USCORE' => 1, - '_LT_AC_LANG_GCJ' => 1, - 'AM_PROG_INSTALL_STRIP' => 1, - 'AC_LTDL_SYSSEARCHPATH' => 1 + 'AC_LIBTOOL_SYS_GLOBAL_SYMBOL_PIPE' => 1, + '_LT_AC_PROG_ECHO_BACKSLASH' => 1, + '_LT_LINKER_OPTION' => 1, + 'LT_LIB_M' => 1, + 'AC_LIBTOOL_PROG_CC_C_O' => 1 } ], 'Autom4te::Request' ), bless( [ '3', 1, [ '/usr/share/autoconf' ], [ '/usr/share/autoconf/autoconf/autoconf.m4f', '-', '/usr/share/aclocal-1.15/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.15/amversion.m4', '/usr/share/aclocal-1.15/auxdir.m4', '/usr/share/aclocal-1.15/cond.m4', '/usr/share/aclocal-1.15/depend.m4', '/usr/share/aclocal-1.15/depout.m4', '/usr/share/aclocal-1.15/extra-recurs.m4', '/usr/share/aclocal-1.15/init.m4', '/usr/share/aclocal-1.15/install-sh.m4', '/usr/share/aclocal-1.15/lead-dot.m4', '/usr/share/aclocal-1.15/make.m4', '/usr/share/aclocal-1.15/missing.m4', '/usr/share/aclocal-1.15/options.m4', '/usr/share/aclocal-1.15/prog-cc-c-o.m4', '/usr/share/aclocal-1.15/runlog.m4', '/usr/share/aclocal-1.15/sanity.m4', '/usr/share/aclocal-1.15/silent.m4', '/usr/share/aclocal-1.15/strip.m4', '/usr/share/aclocal-1.15/substnot.m4', '/usr/share/aclocal-1.15/tar.m4', 'm4/libtool.m4', 'm4/ltoptions.m4', 'm4/ltsugar.m4', 'm4/ltversion.m4', 'm4/lt~obsolete.m4', 'configure.ac' ], { 'PKG_INSTALLDIR' => 1, - 'LT_FUNC_DLSYM_USCORE' => 1, - '_AM_OUTPUT_DEPENDENCY_COMMANDS' => 1, - 'AM_ENABLE_SHARED' => 1, - 'LT_PROG_RC' => 1, - 'AM_MISSING_HAS_RUN' => 1, - 'AC_ENABLE_FAST_INSTALL' => 1, - 'AC_CHECK_LIBM' => 1, - '_AM_AUTOCONF_VERSION' => 1, - 'AC_LIBTOOL_LANG_CXX_CONFIG' => 1, - 'AC_LIBTOOL_LANG_GCJ_CONFIG' => 1, - '_LT_LINKER_BOILERPLATE' => 1, - 'AM_OUTPUT_DEPENDENCY_COMMANDS' => 1, - '_AM_PROG_TAR' => 1, - 'AC_LIBTOOL_SYS_OLD_ARCHIVE' => 1, + 'PKG_CHECK_EXISTS' => 1, + 'AC_LIB_LTDL' => 1, + 'AM_RUN_LOG' => 1, 'AM_SET_DEPDIR' => 1, - '_LT_AC_TAGCONFIG' => 1, - 'AM_DISABLE_STATIC' => 1, - '_LT_PROG_LTMAIN' => 1, - 'AC_LIBTOOL_OBJDIR' => 1, - 'LT_LIB_M' => 1, - '_LT_AC_LANG_F77_CONFIG' => 1, - 'AC_LIBTOOL_SETUP' => 1, 'AC_LIBTOOL_COMPILER_OPTION' => 1, - 'AC_LIBTOOL_SYS_DYNAMIC_LINKER' => 1, - 'AC_LIBTOOL_LINKER_OPTION' => 1, - 'AM_SUBST_NOTMAKE' => 1, - 'AC_LIBTOOL_GCJ' => 1, - 'AC_LIBTOOL_LANG_C_CONFIG' => 1, - '_LT_AC_LANG_RC_CONFIG' => 1, - 'AM_PROG_LD' => 1, - 'AC_WITH_LTDL' => 1, - 'PKG_CHECK_MODULES' => 1, - 'AC_LIBTOOL_PROG_LD_SHLIBS' => 1, 'LT_AC_PROG_SED' => 1, - 'AC_LIBTOOL_SYS_GLOBAL_SYMBOL_PIPE' => 1, - '_LTDL_SETUP' => 1, - 'AC_LIBTOOL_RC' => 1, - '_LT_AC_LANG_F77' => 1, - 'AC_DEFUN' => 1, - '_AC_AM_CONFIG_HEADER_HOOK' => 1, - '_LT_AC_LANG_C_CONFIG' => 1, - 'AM_SET_LEADING_DOT' => 1, - 'AC_DEPLIBS_CHECK_METHOD' => 1, - '_LT_AC_TAGVAR' => 1, - 'AM_INIT_AUTOMAKE' => 1, - 'AC_LIBTOOL_PROG_CC_C_O' => 1, + 'PKG_CHECK_MODULES_STATIC' => 1, + '_AM_SET_OPTIONS' => 1, + 'AM_PROG_LD' => 1, + '_LT_PATH_TOOL_PREFIX' => 1, + 'LT_SYS_DLOPEN_SELF' => 1, + 'AC_LTDL_DLLIB' => 1, + 'AM_SANITY_CHECK' => 1, 'LTVERSION_VERSION' => 1, - 'AC_CONFIG_MACRO_DIR' => 1, - 'LTOBSOLETE_VERSION' => 1, - 'AU_DEFUN' => 1, - '_AM_MANGLE_OPTION' => 1, - 'AC_PROG_LD_GNU' => 1, - 'AC_LIBTOOL_DLOPEN' => 1, - 'LTDL_INSTALLABLE' => 1, - 'AC_LIBTOOL_WIN32_DLL' => 1, - '_AM_IF_OPTION' => 1, - 'AC_LTDL_PREOPEN' => 1, - '_AM_SUBST_NOTMAKE' => 1, - '_LT_LIBOBJ' => 1, - 'AM_PROG_NM' => 1, + '_LT_REQUIRED_DARWIN_CHECKS' => 1, + 'AC_LTDL_DLSYM_USCORE' => 1, + '_LT_AC_SYS_COMPILER' => 1, 'AM_MISSING_PROG' => 1, - 'm4_pattern_allow' => 1, - 'AC_LIBTOOL_SYS_HARD_LINK_LOCKS' => 1, + '_LT_PROG_CXX' => 1, + 'LT_SYS_SYMBOL_USCORE' => 1, + 'PKG_PROG_PKG_CONFIG' => 1, + 'm4_include' => 1, + 'AM_EXTRA_RECURSIVE_TARGETS' => 1, + 'AC_PATH_MAGIC' => 1, + '_LT_AC_LANG_F77_CONFIG' => 1, + 'LT_AC_PROG_GCJ' => 1, + '_AC_AM_CONFIG_HEADER_HOOK' => 1, + 'AC_LIBTOOL_GCJ' => 1, 'include' => 1, - 'AC_DISABLE_SHARED' => 1, - 'LTDL_CONVENIENCE' => 1, - 'AM_ENABLE_STATIC' => 1, 'AC_PROG_NM' => 1, - 'LT_SYS_MODULE_EXT' => 1, - 'AC_LTDL_SYSSEARCHPATH' => 1, - 'AM_PROG_INSTALL_STRIP' => 1, - '_LT_AC_LANG_GCJ' => 1, - 'AM_SET_CURRENT_AUTOMAKE_VERSION' => 1, - 'AC_LTDL_DLSYM_USCORE' => 1, - 'AC_LIBTOOL_CONFIG' => 1, - '_LT_AC_LOCK' => 1, - 'AC_LTDL_DLLIB' => 1, - 'PKG_NOARCH_INSTALLDIR' => 1, - 'LTSUGAR_VERSION' => 1, - 'AC_LIBLTDL_INSTALLABLE' => 1, - 'AC_PROG_LD' => 1, - 'AM_PROG_LIBTOOL' => 1, - 'LT_WITH_LTDL' => 1, - 'AC_LIBTOOL_PROG_COMPILER_NO_RTTI' => 1, - '_LT_AC_SHELL_INIT' => 1, - 'LT_SYS_DLSEARCH_PATH' => 1, - 'AM_SILENT_RULES' => 1, - 'LT_CONFIG_LTDL_DIR' => 1, - '_LT_PROG_FC' => 1, - '_LT_PROG_F77' => 1, - 'AC_PATH_TOOL_PREFIX' => 1, - '_AM_SET_OPTION' => 1, - '_LT_DLL_DEF_P' => 1, - 'LT_LANG' => 1, - 'AM_MAKE_INCLUDE' => 1, - 'AC_LIBTOOL_SYS_LIB_STRIP' => 1, - '_LT_AC_CHECK_DLFCN' => 1, - 'AC_LIBTOOL_SYS_MAX_CMD_LEN' => 1, + 'AM_DEP_TRACK' => 1, 'AC_LIBTOOL_FC' => 1, - 'AC_LIBTOOL_POSTDEP_PREDEP' => 1, - 'AC_ENABLE_STATIC' => 1, - 'AM_SANITY_CHECK' => 1, - 'LT_INIT' => 1, - 'm4_include' => 1, - 'LTOPTIONS_VERSION' => 1, + 'AC_LIBTOOL_RC' => 1, 'AC_LTDL_ENABLE_INSTALL' => 1, - 'LT_SYS_MODULE_PATH' => 1, - 'AC_LIBTOOL_PROG_COMPILER_PIC' => 1, - 'AM_PROG_INSTALL_SH' => 1, + 'AC_ENABLE_FAST_INSTALL' => 1, + 'AC_LIBLTDL_INSTALLABLE' => 1, + 'AM_SILENT_RULES' => 1, + 'AC_LIBTOOL_SYS_GLOBAL_SYMBOL_PIPE' => 1, + 'AC_LIBTOOL_PROG_CC_C_O' => 1, + 'LT_LIB_M' => 1, '_LT_AC_PROG_ECHO_BACKSLASH' => 1, - 'LT_PROG_GCJ' => 1, - 'AC_LIBTOOL_LANG_F77_CONFIG' => 1, - '_LT_AC_TRY_DLOPEN_SELF' => 1, - 'LT_OUTPUT' => 1, - 'm4_pattern_forbid' => 1, + '_LT_LINKER_OPTION' => 1, + 'AM_AUTOMAKE_VERSION' => 1, + 'LTDL_INSTALLABLE' => 1, + '_LT_AC_LANG_RC_CONFIG' => 1, + '_AM_AUTOCONF_VERSION' => 1, + '_AM_IF_OPTION' => 1, + '_LT_LIBOBJ' => 1, 'AM_AUX_DIR_EXPAND' => 1, - 'AM_DEP_TRACK' => 1, - '_LT_AC_FILE_LTDLL_C' => 1, - '_AM_PROG_CC_C_O' => 1, + '_LT_COMPILER_BOILERPLATE' => 1, + 'LT_SYS_DLSEARCH_PATH' => 1, + '_LT_CC_BASENAME' => 1, + 'LT_FUNC_DLSYM_USCORE' => 1, + 'AC_LIBTOOL_CXX' => 1, + '_LT_WITH_SYSROOT' => 1, + 'AM_PROG_LIBTOOL' => 1, + 'AM_CONDITIONAL' => 1, + 'AM_INIT_AUTOMAKE' => 1, + '_LT_AC_LANG_GCJ' => 1, + 'AC_LTDL_SYSSEARCHPATH' => 1, + 'LT_INIT' => 1, + 'AC_LTDL_SHLIBEXT' => 1, + 'AC_CHECK_LIBM' => 1, + '_AM_OUTPUT_DEPENDENCY_COMMANDS' => 1, + '_LT_AC_SHELL_INIT' => 1, 'AC_LIBTOOL_PROG_LD_HARDCODE_LIBPATH' => 1, - 'LT_LIB_DLLOAD' => 1, - 'LT_PATH_LD' => 1, - '_LT_AC_LANG_GCJ_CONFIG' => 1, - 'AC_LTDL_SYMBOL_USCORE' => 1, - 'LT_SYS_DLOPEN_SELF' => 1, - 'AM_AUTOMAKE_VERSION' => 1, + 'LT_SYS_MODULE_EXT' => 1, + '_LT_AC_LANG_C_CONFIG' => 1, + 'LT_AC_PROG_RC' => 1, + 'AC_DISABLE_FAST_INSTALL' => 1, 'PKG_CHECK_VAR' => 1, - '_AM_CONFIG_MACRO_DIRS' => 1, + 'LT_SYS_MODULE_PATH' => 1, + 'PKG_NOARCH_INSTALLDIR' => 1, + 'AC_LIBTOOL_LINKER_OPTION' => 1, 'AM_PROG_CC_C_O' => 1, - 'AC_LIBTOOL_PICMODE' => 1, - '_LT_CC_BASENAME' => 1, - 'AC_LIBTOOL_LANG_RC_CONFIG' => 1, - 'AC_LIBTOOL_DLOPEN_SELF' => 1, + 'AC_LTDL_SHLIBPATH' => 1, + 'm4_pattern_forbid' => 1, + 'AC_ENABLE_STATIC' => 1, + 'AC_LIBTOOL_SYS_MAX_CMD_LEN' => 1, + '_LT_PROG_FC' => 1, + 'AC_LIBTOOL_DLOPEN' => 1, + '_LT_AC_LANG_CXX' => 1, + 'AC_LIBTOOL_OBJDIR' => 1, + 'PKG_CHECK_MODULES' => 1, + '_LT_COMPILER_OPTION' => 1, 'AC_PROG_LIBTOOL' => 1, - '_LT_PREPARE_SED_QUOTE_VARS' => 1, - '_m4_warn' => 1, + 'LTOBSOLETE_VERSION' => 1, + 'AC_DEFUN_ONCE' => 1, + '_LT_AC_TAGCONFIG' => 1, + '_LT_AC_CHECK_DLFCN' => 1, + 'AM_ENABLE_STATIC' => 1, + '_AM_SUBST_NOTMAKE' => 1, + '_LT_AC_LANG_CXX_CONFIG' => 1, + 'AC_LIBLTDL_CONVENIENCE' => 1, + 'AC_LIBTOOL_WIN32_DLL' => 1, + 'AC_LIBTOOL_LANG_CXX_CONFIG' => 1, + '_LT_AC_LANG_F77' => 1, 'LT_SYS_DLOPEN_DEPLIBS' => 1, + 'AC_LIBTOOL_SYS_HARD_LINK_LOCKS' => 1, + 'LT_CONFIG_LTDL_DIR' => 1, + '_LT_LINKER_BOILERPLATE' => 1, + 'AC_LIBTOOL_LANG_RC_CONFIG' => 1, 'AC_LTDL_OBJDIR' => 1, - 'LT_FUNC_ARGZ' => 1, - 'AC_DISABLE_FAST_INSTALL' => 1, - '_LT_AC_LANG_CXX' => 1, - '_LT_WITH_SYSROOT' => 1, - 'PKG_CHECK_EXISTS' => 1, + 'LT_AC_PROG_EGREP' => 1, + 'LT_PROG_RC' => 1, 'LTDL_INIT' => 1, - 'AM_CONDITIONAL' => 1, - '_LT_PATH_TOOL_PREFIX' => 1, - 'LT_SUPPORTED_TAG' => 1, - 'LT_CMD_MAX_LEN' => 1, - 'AC_DISABLE_STATIC' => 1, - '_LT_AC_SYS_COMPILER' => 1, - 'LT_PROG_GO' => 1, - 'AC_LTDL_SYS_DLOPEN_DEPLIBS' => 1, - 'LT_SYS_SYMBOL_USCORE' => 1, - 'LT_AC_PROG_GCJ' => 1, - '_PKG_SHORT_ERRORS_SUPPORTED' => 1, - 'AC_ENABLE_SHARED' => 1, - 'LT_AC_PROG_RC' => 1, - 'AC_LIBTOOL_CXX' => 1, + 'AC_LTDL_PREOPEN' => 1, + 'AC_LIBTOOL_PROG_COMPILER_NO_RTTI' => 1, + 'AM_SET_CURRENT_AUTOMAKE_VERSION' => 1, + '_AM_DEPENDENCIES' => 1, + '_LT_AC_TAGVAR' => 1, + 'LT_PATH_LD' => 1, + 'LTSUGAR_VERSION' => 1, + 'AC_DEPLIBS_CHECK_METHOD' => 1, '_LT_AC_PROG_CXXCPP' => 1, - '_LT_LINKER_OPTION' => 1, - '_LT_PROG_CXX' => 1, - 'AC_PATH_MAGIC' => 1, + 'AM_PROG_INSTALL_SH' => 1, + 'AC_LIBTOOL_LANG_C_CONFIG' => 1, + '_AC_PROG_LIBTOOL' => 1, + 'AM_ENABLE_SHARED' => 1, 'LT_PATH_NM' => 1, - 'AC_PROG_LD_RELOAD_FLAG' => 1, - '_AM_SET_OPTIONS' => 1, - 'AC_LIBLTDL_CONVENIENCE' => 1, - 'AC_LTDL_SHLIBPATH' => 1, - 'AC_LTDL_SHLIBEXT' => 1, + 'LT_OUTPUT' => 1, + 'AC_PROG_EGREP' => 1, + 'AM_DISABLE_STATIC' => 1, + 'AM_DISABLE_SHARED' => 1, + '_LT_AC_LANG_GCJ_CONFIG' => 1, + 'AC_LIBTOOL_POSTDEP_PREDEP' => 1, + '_LT_PROG_LTMAIN' => 1, + 'AM_SET_LEADING_DOT' => 1, + '_AM_CONFIG_MACRO_DIRS' => 1, + 'AC_LIBTOOL_CONFIG' => 1, + 'AC_DISABLE_SHARED' => 1, + '_AM_MANGLE_OPTION' => 1, + 'AC_LIBTOOL_PROG_LD_SHLIBS' => 1, + 'AM_PROG_INSTALL_STRIP' => 1, + '_LT_AC_SYS_LIBPATH_AIX' => 1, + 'AC_DISABLE_STATIC' => 1, 'AC_LIBTOOL_F77' => 1, + 'AM_SUBST_NOTMAKE' => 1, + 'AM_MISSING_HAS_RUN' => 1, + 'LT_CMD_MAX_LEN' => 1, + '_LT_AC_FILE_LTDLL_C' => 1, + 'AC_LIBTOOL_SETUP' => 1, + 'AM_PROG_NM' => 1, + 'LT_WITH_LTDL' => 1, + 'LT_SUPPORTED_TAG' => 1, + 'AC_LIBTOOL_PICMODE' => 1, + 'm4_pattern_allow' => 1, + 'LT_FUNC_ARGZ' => 1, + 'AC_LTDL_SYS_DLOPEN_DEPLIBS' => 1, + 'AC_CONFIG_MACRO_DIR' => 1, + 'AC_LIBTOOL_DLOPEN_SELF' => 1, + '_AM_SET_OPTION' => 1, + 'AC_LIBTOOL_SYS_DYNAMIC_LINKER' => 1, 'AC_CONFIG_MACRO_DIR_TRACE' => 1, - 'AM_RUN_LOG' => 1, - '_LT_REQUIRED_DARWIN_CHECKS' => 1, - 'AC_DEFUN_ONCE' => 1, - 'PKG_CHECK_MODULES_STATIC' => 1, - '_LT_COMPILER_BOILERPLATE' => 1, - 'AM_DISABLE_SHARED' => 1, - '_AC_PROG_LIBTOOL' => 1, + 'AM_OUTPUT_DEPENDENCY_COMMANDS' => 1, '_LT_PROG_ECHO_BACKSLASH' => 1, - 'LT_AC_PROG_EGREP' => 1, - 'PKG_PROG_PKG_CONFIG' => 1, - '_LT_AC_LANG_CXX_CONFIG' => 1, - '_LT_AC_SYS_LIBPATH_AIX' => 1, - '_AM_DEPENDENCIES' => 1, - '_LT_COMPILER_OPTION' => 1, - 'AM_EXTRA_RECURSIVE_TARGETS' => 1, - 'AC_PROG_EGREP' => 1, - 'AC_LIB_LTDL' => 1 + 'AC_LTDL_SYMBOL_USCORE' => 1, + 'LTDL_CONVENIENCE' => 1, + 'AC_ENABLE_SHARED' => 1, + 'AC_LIBTOOL_PROG_COMPILER_PIC' => 1, + '_LT_DLL_DEF_P' => 1, + 'AC_PATH_TOOL_PREFIX' => 1, + 'AC_LIBTOOL_LANG_GCJ_CONFIG' => 1, + 'AM_MAKE_INCLUDE' => 1, + '_LT_AC_TRY_DLOPEN_SELF' => 1, + 'LT_LIB_DLLOAD' => 1, + '_LT_AC_LOCK' => 1, + '_AM_PROG_TAR' => 1, + 'LT_PROG_GO' => 1, + '_AM_PROG_CC_C_O' => 1, + 'AC_LIBTOOL_SYS_OLD_ARCHIVE' => 1, + '_LT_PREPARE_SED_QUOTE_VARS' => 1, + 'AC_DEFUN' => 1, + 'AC_PROG_LD_GNU' => 1, + 'LT_PROG_GCJ' => 1, + 'AC_PROG_LD_RELOAD_FLAG' => 1, + '_LT_PROG_F77' => 1, + 'AU_DEFUN' => 1, + '_m4_warn' => 1, + '_PKG_SHORT_ERRORS_SUPPORTED' => 1, + 'LTOPTIONS_VERSION' => 1, + 'AC_LIBTOOL_SYS_LIB_STRIP' => 1, + '_LTDL_SETUP' => 1, + 'AC_LIBTOOL_LANG_F77_CONFIG' => 1, + 'AC_PROG_LD' => 1, + 'LT_LANG' => 1, + 'AC_WITH_LTDL' => 1 } ], 'Autom4te::Request' ) );