Page Menu
Home
HEPForge
Search
Configure Global Search
Log In
Files
F10881435
No One
Temporary
Actions
View File
Edit File
Delete File
View Transforms
Subscribe
Mute Notifications
Award Token
Flag For Later
Size
241 KB
Subscribers
None
View Options
Index: trunk/npstat/nm/vectorAsText.hh
===================================================================
--- trunk/npstat/nm/vectorAsText.hh (revision 0)
+++ trunk/npstat/nm/vectorAsText.hh (revision 877)
@@ -0,0 +1,122 @@
+#ifndef NPSTAT_VECTORASTEXT_HH_
+#define NPSTAT_VECTORASTEXT_HH_
+
+/*!
+// \file vectorAsText.hh
+//
+// \brief Utilities for reading/writing std::vector objects from/to text files
+//
+// Author: I. Volobouev
+//
+// January 2023
+*/
+
+#include <iostream>
+#include <sstream>
+#include <string>
+#include <vector>
+#include <climits>
+
+namespace npstat {
+ /**
+ // Function for dumping vectors into text files, one element per line.
+ //
+ // Note that, while this function will work with T objects that do
+ // not have default constructors, it will not be possible to read
+ // such objects back.
+ //
+ // "true" is returned on success, "false" on failure.
+ // Dumping less than "nElementsToDump" elements is considered
+ // a success.
+ */
+ template <typename T>
+ bool dumpVectorAsText(const std::vector<T>& v,
+ std::ostream& asciiStream,
+ const unsigned long firstElementToDump=0,
+ const unsigned long nElementsToDump=ULONG_MAX)
+ {
+ if (nElementsToDump)
+ {
+ const unsigned long sz = v.size();
+ if (firstElementToDump < sz)
+ {
+ unsigned long ndumped = 0;
+ for (unsigned long i=firstElementToDump;
+ i<sz && ndumped<nElementsToDump; ++i, ++ndumped)
+ asciiStream << v[i] << '\n';
+ if (asciiStream.fail())
+ return false;
+ }
+ }
+ return true;
+ }
+
+ /**
+ // Function for filling vectors from text files, one element per line.
+ // Will only work with T objects that have default constructors.
+ // "true" is returned on success, "false" on failure.
+ //
+ // Empty lines, lines which consist of pure white space, and lines
+ // which start with an arbitrary amount of white space (including
+ // none) followed by '#' are ignored (considered comments).
+ */
+ template <typename T>
+ bool fillVectorFromText(std::istream& asciiStream,
+ std::vector<T>* v,
+ const unsigned long maxElementsToFill=ULONG_MAX)
+ {
+ bool status = true;
+ if (maxElementsToFill && asciiStream)
+ {
+ assert(v);
+ std::string linebuf;
+ std::istringstream is;
+ unsigned long nfilled = 0;
+ T buffer;
+
+ while (asciiStream && status && nfilled<maxElementsToFill)
+ {
+ std::getline(asciiStream, linebuf);
+ const unsigned long len = linebuf.size();
+ if (len == 0UL)
+ continue;
+
+ // Ignore lines which are pure white space
+ // or which start with an arbitrary number
+ // of white space characters followed by #.
+ bool isComment = false;
+ bool allSpace = true;
+ char* line = &linebuf[0];
+
+ for (unsigned long i=0; i<len; ++i)
+ {
+ if (isspace(line[i]))
+ continue;
+ if (allSpace && line[i] == '#')
+ {
+ isComment = true;
+ break;
+ }
+ allSpace = false;
+ }
+ if (isComment || allSpace)
+ continue;
+
+ is.str(linebuf);
+ is.clear();
+ is >> buffer;
+ if (is.fail())
+ status = false;
+ else
+ v->push_back(buffer);
+
+ if ((asciiStream.fail() && !asciiStream.eof()) ||
+ asciiStream.bad())
+ status = false;
+ }
+ }
+ return status;
+ }
+}
+
+#endif // NPSTAT_VECTORASTEXT_HH_
Index: trunk/npstat/nm/00README.txt
===================================================================
--- trunk/npstat/nm/00README.txt (revision 876)
+++ trunk/npstat/nm/00README.txt (revision 877)
@@ -1,346 +1,349 @@
The code in this directory should not depend on headers from any other
directory of the "npstat" package.
This directory contains implementations for a number of useful mathematical
objects, integration and root finding codes, etc. The classes and functions
can be approximately split into the following subject groups:
* Multidimensional arrays, grids, and related utilities
* Optimization and root finding
* Integration
* Interpolation
* Orthogonal polynomials and filtering
* Searcheable multidimensional structures
* Miscellaneous utilities
Multidimensional arrays, grids, and related utilities
-----------------------------------------------------
ArrayND.hh -- Multidimensional array template.
ArrayNDScanner.hh -- A class which can be used to iterate over
multidimensional array indices. Useful when
the array itself is not available (for example,
for iterating over slices, etc).
AbsArrayProjector.hh -- Interface class used in iterations over array
elements.
AbsMultivariateFunctor.hh -- Interface class for a variety of multivariate
functor-based calculations.
CoordinateSelector.hh -- A trivial AbsMultivariateFunctor implementation
which selects one of the elements from the input
array.
MultivariateFunctorScanner.hh -- Utility for filling array values from
multivariate functors.
AbsVisitor.hh -- Another interface class used in iterations over
array elements. Use this if elements indices is
not of interest and only the array value is used.
ArrayRange.hh -- Used in constructing array subranges.
ArrayShape.hh -- Defines the shape of multidimensional arrays.
BoundaryInclusion.hh -- Enumeration of possible boundary inclusions
for an interval.
BoxND.hh -- Represents rectangles, boxes, and hyperboxes
BoxNDScanner.hh -- A class for iterating over all coordinates in
a multidimensional box (like using histogram
bin centers).
EigenMethod.hh -- Helper enum for use with Matrix methods for
finding eigenvalues and eigenvectors.
SvdMethod.hh -- Helper enum for use with Matrix methods for
performing singular value decompositions.
GridAxis.hh -- Can be used to define an axis of a rectangular
grid (not necessarily equidistant).
Interval.hh -- 1-d intervals. Used by BoxND to bulid boxes.
Matrix.hh -- A simple matrix template. Outsorces most of its
more advanced functionality to LAPACK.
matrixIndexPairs.hh -- A utlitity for enumerating matrix elements on
the main diagonal and above.
PointDimensionality.hh -- Compile-time dimensionality detector for classes
like std::array.
UniformAxis.hh -- Can be used to define an equidistant axis of
a rectangular grid.
DualAxis.hh -- Can be used to define either equidistant or
non-uniform axis, with O(1) coordinate lookup
for equidistant grids.
fillArrayCentersPreservingAreas.hh -- It is assumed that we have an array
with the number of elements increased by an integer
factor in each dimension in comparison with the
original array. This array is filled from the
original one in the manner appropriate for
subsequent smoothing. This is useful in certain
rebinning situations, when some quantity calculated
on some grid needs to be smoothed and interpolated
on a denser grid.
truncatedInverseSqrt.hh -- Truncate the square root of a symmetric positive
semidefinite matrix by keeping eigenvectors
corresponding to largest eigenvalues.
Optimization and root finding
-----------------------------
MinSearchStatus1D.hh -- Status of minimum search on a 1-d interval.
findPeak2D.hh -- Reliable peak finding on 2-d grids.
goldenSectionSearch.hh -- Search for 1-d function minimum using the
golden section method.
findRootInLogSpace.hh -- Search for a solution of a single equation of
the type f(x) == rhs where x is some type that
can be multiplied by a positive double. Uses
interval division.
findRootNewtonRaphson.hh -- Search for a solution of a single equation of
the type f(x) == rhs using the Newton-Raphson
method.
findRootUsingBisections.hh -- Search for a solution of a single equation of
the type f(x) == rhs using bisections.
ScanExtremum1D.hh -- Search for extrema of scanned 1-d curves.
See also "MathUtils.hh" header for codes that find roots of quadratic
and cubic equations.
Integration
-----------
AbsIntervalQuadrature1D.hh -- Base class for 1-d quadratures on a closed
interval.
FejerQuadrature.hh -- 1-d Fejer quadratures (essentially, using
Chebyshev polynomials).
Gauss1DQuadrature.hh -- 1-d Gauss-Hermite quadrature utilizing
"probabilists'" Hermite polynomials with
user-defined location and scale.
GaussHermiteQuadrature.hh -- 1-d Gaussian quadratures using Hermite
polynomials.
GaussLegendreQuadrature.hh -- 1-d Gaussian quadratures using Legendre
polynomials.
GaussLegendreQuadratureQ.hh -- 1-d Gaussian quadratures using Legendre
polynomials, in quadruple precision.
GaussLegendreQuadrature2D.hh -- 2-d tensor-product Gaussian quadratures
using Legendre polynomials.
rectangleQuadrature.hh -- Gaussian quadratures on rectangles and
hyperrectangles using tensor product integration.
RectangleQuadrature1D.hh -- Rectangle integration rule in 1-d.
SemiInfGaussianQuadrature.hh -- Quadrature on the [0, Inf] interval with
weight exp(-x^2/2)
Interpolation
-------------
bilinearSection.hh -- Finds the contours of the intersection of a bilinear
interpolation cell (specified by values at the
corners of the unit square) with a given constant
level. For use in higher-level mapping and
contouring algorithms.
interpolate.hh -- Simple interpolating polynomials (linear, quadratic,
cubic) on regularly spaced 1-d grids.
LinInterpolatedTable1D.hh -- Linearly interpolated table in 1-d.
LinInterpolatedTableND.hh -- Interpolated table in multiple dimensions
(with multilinear interpolation).
LinearMapper1d.hh -- Linear functor in 1-d for use in interpolation
and extrapolation.
CircularMapper1d.hh -- Linear coordinate mapper for circular topologies.
LogMapper1d.hh -- Functor which is linear in log(x). Useful for
interpolating functions of strictly positive
quantities.
ExpMapper1d.hh -- Functor which is linear in log(y). Useful for
interpolating functions that are strictly positive.
rescanArray.hh -- A utility for filling one array using values of
another. The arrays are treated as values of
histogram bins inside the unit box, and
interpolations are performed as necessary.
Orthogonal polynomials and filtering
------------------------------------
AbsClassicalOrthoPoly1D.hh -- Base class for classical orthogonal polynomials.
ClassicalOrthoPoly1DFromWeight.hh -- Orthogonal polynomials on an interval
with an arbitrary user-provided weght function.
ClassicalOrthoPolys1D.hh -- Concrete implementations of various classical
orthogonal polynomials (Legendre, Jacobi, etc).
ContOrthoPoly1D.hh -- Continuous orthogonal polynomials for discrete
measures (intended for constructing empirical
chaos polynomials).
ConvolutionEngine1D.hh -- FFTW double precision interface to be used
for implementing convolutions in 1-d.
ConvolutionEngineND.hh -- FFTW double precision interface to be used
for implementing convolutions on grids
of arbitrary dimensionality.
DiscreteBernsteinPoly1D.hh -- Discrete Bernstein polynomials in one dimension
(preserving the partition of unity property).
FourierImage.hh -- Wrapper class for memory blocks allocated by
fftw_malloc and deallocated by fftw_free.
Intended for storing results of Fourier transforms.
HeatEq1DNeumannBoundary.hh -- Solution of 1-d heat equation with Neumann
boundary conditions (no heat transfer through
the boundary). Useful mainly for generating
doubly stochastic matrices.
kernelSensitivityMatrix.hh -- Calculation of the sensitivity matrix
for KDE-like density estimation.
OrthoPoly1D.hh -- Discrete orthogonal polynomials in 1-d (typically,
for use in linear filters).
OrthoPolyND.hh -- Discrete orthogonal polynomials of arbitrary
dimensionality in hyperrectangular domains.
OrthoPolyMethod.hh -- Enum for the methods used to construct the
continuous polynomials (class ContOrthoPoly1D).
sineTransformMatrix.hh -- Matrix for the simple (not fast) sine transform
on the [0, 1] interval.
ScalableClassicalOrthoPoly1D.hh -- Class for scaling and shifting classical
orthogonal polynomials.
StorablePolySeries1D.hh -- Storable functor for orthogonal polynomial series.
See also "MathUtils.hh" header for codes that calculate series for some
classical orthogonal polynomial systems.
Searcheable multidimensional structures
---------------------------------------
CompareByIndex.hh -- Comparison functor for objects that support
subsripting. Used by k-d tree code.
KDTree.hh -- Balanced k-d tree implementation. All points
must be known in advance.
Miscellaneous utilities
-----------------------
absDifference.hh -- Proper calculation of absolute value and absolute
difference of two values for a number of types
including unsigned, complex, etc.
allocators.hh -- A few utility functions related to memory management.
areAllElementsUnique.hh -- A simple template for checking uniqueness of
container values using O(N^2) algorithm.
binomialCoefficient.hh -- Calculation of binomial coefficients which avoids
overflows.
closeWithinTolerance.hh -- Closeness comparison for doubles.
ComplexComparesAbs.hh -- Use ComplexComparesAbs<T>::less in the templated
ComplexComparesFalse.hh code when it makes sense to do comparison of complex
numbers by magnitude and comparison of other types
by "operator<". ComplexComparesFalse<T>::less returns
"false" for complex types and compares other types
with "operator<". "more" methods are similar.
ConstSubscriptMap.hh -- A variation of std::map template with const
subscripting operator.
definiteIntegrals.hh -- Definite integrals based on exact expressions.
discretizedDistance.hh -- L1 and L2 distances for discretized functions.
EquidistantSequence.hh -- Sequences of points equidistant in 1-d linear
or log space.
fcnOrConst.hh -- Some templated utilities for use in various
density estimation codes.
GaussianDip.hh -- "Gaussian dip" function.
GeneralizedComplex.hh -- Define a type which will be set to std::complex<T>
for T from float, double, and long double, and to
T for all other types.
isMonotonous.hh -- A few simple templates for checking monotonicity
of container values.
lapack.h -- LAPACK-related declarations (F77 versions).
lapack_interface.hh -- High-level interface to some of the LAPACK functions.
LongerType.hh -- "Longer" type deduction for binary operations.
MathUtils.hh -- Miscellaneous utilities.
PairCompare.hh -- Additional comparison functors for std::pair.
performSchultzIteration.hh -- Schultz iteration for calculating matrix
inverses in long double precision (used
internally by the Matrix class).
PreciseType.hh -- PreciseType<T>::type is typedefed to "long double"
for primitive scalar types and to
"std::complex<long double>" for complex types.
ProperDblFromCmpl.hh -- ProperDblFromCmpl<T>::type is a floating point type
which can be multiplied by T when T is complex,
otherwise it is just "double".
PtrBufferHandle.hh -- Resource handler for an array of pointers to
explicitly allocated objects (to complement a vector
of pointers). Not for use by application code.
SimpleFunctors.hh -- Interface classes and concrete simple functors
for a variety of functor-based calculations.
SpecialFunctions.hh -- Special functions.
sumOfSquares.hh -- Calculate the sum of squares of elements inside
a contiguous buffer.
timestamp.hh -- Generate a trivial time stamp in the format hh:mm:ss.
Triple.hh -- A template with three members, similar to
std::pair in purpose and functionality.
+
+vectorAsText.hh -- Utilities for dumping std::vector objects into
+ text files and reading them from files.
Index: trunk/npstat/nm/Makefile
===================================================================
--- trunk/npstat/nm/Makefile (revision 876)
+++ trunk/npstat/nm/Makefile (revision 877)
@@ -1,1027 +1,1028 @@
# Makefile.in generated by automake 1.16.5 from Makefile.am.
# npstat/nm/Makefile. Generated from Makefile.in by configure.
# Copyright (C) 1994-2021 Free Software Foundation, Inc.
# This Makefile.in is free software; the Free Software Foundation
# gives unlimited permission to copy and/or distribute it,
# with or without modifications, as long as this notice is preserved.
# This program is distributed in the hope that it will be useful,
# but WITHOUT ANY WARRANTY, to the extent permitted by law; without
# even the implied warranty of MERCHANTABILITY or FITNESS FOR A
# PARTICULAR PURPOSE.
am__is_gnu_make = { \
if test -z '$(MAKELEVEL)'; then \
false; \
elif test -n '$(MAKE_HOST)'; then \
true; \
elif test -n '$(MAKE_VERSION)' && test -n '$(CURDIR)'; then \
true; \
else \
false; \
fi; \
}
am__make_running_with_option = \
case $${target_option-} in \
?) ;; \
*) echo "am__make_running_with_option: internal error: invalid" \
"target option '$${target_option-}' specified" >&2; \
exit 1;; \
esac; \
has_opt=no; \
sane_makeflags=$$MAKEFLAGS; \
if $(am__is_gnu_make); then \
sane_makeflags=$$MFLAGS; \
else \
case $$MAKEFLAGS in \
*\\[\ \ ]*) \
bs=\\; \
sane_makeflags=`printf '%s\n' "$$MAKEFLAGS" \
| sed "s/$$bs$$bs[$$bs $$bs ]*//g"`;; \
esac; \
fi; \
skip_next=no; \
strip_trailopt () \
{ \
flg=`printf '%s\n' "$$flg" | sed "s/$$1.*$$//"`; \
}; \
for flg in $$sane_makeflags; do \
test $$skip_next = yes && { skip_next=no; continue; }; \
case $$flg in \
*=*|--*) continue;; \
-*I) strip_trailopt 'I'; skip_next=yes;; \
-*I?*) strip_trailopt 'I';; \
-*O) strip_trailopt 'O'; skip_next=yes;; \
-*O?*) strip_trailopt 'O';; \
-*l) strip_trailopt 'l'; skip_next=yes;; \
-*l?*) strip_trailopt 'l';; \
-[dEDm]) skip_next=yes;; \
-[JT]) skip_next=yes;; \
esac; \
case $$flg in \
*$$target_option*) has_opt=yes; break;; \
esac; \
done; \
test $$has_opt = yes
am__make_dryrun = (target_option=n; $(am__make_running_with_option))
am__make_keepgoing = (target_option=k; $(am__make_running_with_option))
pkgdatadir = $(datadir)/npstat
pkgincludedir = $(includedir)/npstat
pkglibdir = $(libdir)/npstat
pkglibexecdir = $(libexecdir)/npstat
am__cd = CDPATH="$${ZSH_VERSION+.}$(PATH_SEPARATOR)" && cd
install_sh_DATA = $(install_sh) -c -m 644
install_sh_PROGRAM = $(install_sh) -c
install_sh_SCRIPT = $(install_sh) -c
INSTALL_HEADER = $(INSTALL_DATA)
transform = $(program_transform_name)
NORMAL_INSTALL = :
PRE_INSTALL = :
POST_INSTALL = :
NORMAL_UNINSTALL = :
PRE_UNINSTALL = :
POST_UNINSTALL = :
build_triplet = x86_64-pc-linux-gnu
host_triplet = x86_64-pc-linux-gnu
subdir = npstat/nm
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)
libnm_la_LIBADD =
am_libnm_la_OBJECTS = ArrayShape.lo ArrayRange.lo SpecialFunctions.lo \
ConvolutionEngine1D.lo EquidistantSequence.lo \
GaussHermiteQuadrature.lo GaussLegendreQuadrature.lo \
MathUtils.lo OrthoPoly1D.lo GridAxis.lo rectangleQuadrature.lo \
LinInterpolatedTable1D.lo ScanExtremum1D.lo bilinearSection.lo \
ConvolutionEngineND.lo FourierImage.lo SvdMethod.lo \
binomialCoefficient.lo UniformAxis.lo ArrayNDScanner.lo \
DualAxis.lo DiscreteBernsteinPoly1D.lo definiteIntegrals.lo \
EigenMethod.lo goldenSectionSearch.lo timestamp.lo \
OrthoPolyMethod.lo ContOrthoPoly1D.lo lapack_interface.lo \
AbsClassicalOrthoPoly1D.lo ClassicalOrthoPolys1D.lo \
matrixIndexPairs.lo truncatedInverseSqrt.lo FejerQuadrature.lo \
StorablePolySeries1D.lo SemiInfGaussianQuadrature.lo \
Gauss1DQuadrature.lo HeatEq1DNeumannBoundary.lo \
performSchultzIteration.lo RecurrenceCoeffs.lo \
GaussLegendreQuadratureQ.lo GaussLegendreQuadrature2D.lo \
Poly1D.lo ScalableClassicalOrthoPoly1D.lo \
RectangleQuadrature1D.lo findPeak2D.lo sineTransformMatrix.lo
libnm_la_OBJECTS = $(am_libnm_la_OBJECTS)
AM_V_lt = $(am__v_lt_$(V))
am__v_lt_ = $(am__v_lt_$(AM_DEFAULT_VERBOSITY))
am__v_lt_0 = --silent
am__v_lt_1 =
AM_V_P = $(am__v_P_$(V))
am__v_P_ = $(am__v_P_$(AM_DEFAULT_VERBOSITY))
am__v_P_0 = false
am__v_P_1 = :
AM_V_GEN = $(am__v_GEN_$(V))
am__v_GEN_ = $(am__v_GEN_$(AM_DEFAULT_VERBOSITY))
am__v_GEN_0 = @echo " GEN " $@;
am__v_GEN_1 =
AM_V_at = $(am__v_at_$(V))
am__v_at_ = $(am__v_at_$(AM_DEFAULT_VERBOSITY))
am__v_at_0 = @
am__v_at_1 =
DEFAULT_INCLUDES = -I.
depcomp = $(SHELL) $(top_srcdir)/depcomp
am__maybe_remake_depfiles = depfiles
am__depfiles_remade = ./$(DEPDIR)/AbsClassicalOrthoPoly1D.Plo \
./$(DEPDIR)/ArrayNDScanner.Plo ./$(DEPDIR)/ArrayRange.Plo \
./$(DEPDIR)/ArrayShape.Plo \
./$(DEPDIR)/ClassicalOrthoPolys1D.Plo \
./$(DEPDIR)/ContOrthoPoly1D.Plo \
./$(DEPDIR)/ConvolutionEngine1D.Plo \
./$(DEPDIR)/ConvolutionEngineND.Plo \
./$(DEPDIR)/DiscreteBernsteinPoly1D.Plo \
./$(DEPDIR)/DualAxis.Plo ./$(DEPDIR)/EigenMethod.Plo \
./$(DEPDIR)/EquidistantSequence.Plo \
./$(DEPDIR)/FejerQuadrature.Plo ./$(DEPDIR)/FourierImage.Plo \
./$(DEPDIR)/Gauss1DQuadrature.Plo \
./$(DEPDIR)/GaussHermiteQuadrature.Plo \
./$(DEPDIR)/GaussLegendreQuadrature.Plo \
./$(DEPDIR)/GaussLegendreQuadrature2D.Plo \
./$(DEPDIR)/GaussLegendreQuadratureQ.Plo \
./$(DEPDIR)/GridAxis.Plo \
./$(DEPDIR)/HeatEq1DNeumannBoundary.Plo \
./$(DEPDIR)/LinInterpolatedTable1D.Plo \
./$(DEPDIR)/MathUtils.Plo ./$(DEPDIR)/OrthoPoly1D.Plo \
./$(DEPDIR)/OrthoPolyMethod.Plo ./$(DEPDIR)/Poly1D.Plo \
./$(DEPDIR)/RectangleQuadrature1D.Plo \
./$(DEPDIR)/RecurrenceCoeffs.Plo \
./$(DEPDIR)/ScalableClassicalOrthoPoly1D.Plo \
./$(DEPDIR)/ScanExtremum1D.Plo \
./$(DEPDIR)/SemiInfGaussianQuadrature.Plo \
./$(DEPDIR)/SpecialFunctions.Plo \
./$(DEPDIR)/StorablePolySeries1D.Plo ./$(DEPDIR)/SvdMethod.Plo \
./$(DEPDIR)/UniformAxis.Plo ./$(DEPDIR)/bilinearSection.Plo \
./$(DEPDIR)/binomialCoefficient.Plo \
./$(DEPDIR)/definiteIntegrals.Plo ./$(DEPDIR)/findPeak2D.Plo \
./$(DEPDIR)/goldenSectionSearch.Plo \
./$(DEPDIR)/lapack_interface.Plo \
./$(DEPDIR)/matrixIndexPairs.Plo \
./$(DEPDIR)/performSchultzIteration.Plo \
./$(DEPDIR)/rectangleQuadrature.Plo \
./$(DEPDIR)/sineTransformMatrix.Plo ./$(DEPDIR)/timestamp.Plo \
./$(DEPDIR)/truncatedInverseSqrt.Plo
am__mv = mv -f
CXXCOMPILE = $(CXX) $(DEFS) $(DEFAULT_INCLUDES) $(INCLUDES) \
$(AM_CPPFLAGS) $(CPPFLAGS) $(AM_CXXFLAGS) $(CXXFLAGS)
LTCXXCOMPILE = $(LIBTOOL) $(AM_V_lt) --tag=CXX $(AM_LIBTOOLFLAGS) \
$(LIBTOOLFLAGS) --mode=compile $(CXX) $(DEFS) \
$(DEFAULT_INCLUDES) $(INCLUDES) $(AM_CPPFLAGS) $(CPPFLAGS) \
$(AM_CXXFLAGS) $(CXXFLAGS)
AM_V_CXX = $(am__v_CXX_$(V))
am__v_CXX_ = $(am__v_CXX_$(AM_DEFAULT_VERBOSITY))
am__v_CXX_0 = @echo " CXX " $@;
am__v_CXX_1 =
CXXLD = $(CXX)
CXXLINK = $(LIBTOOL) $(AM_V_lt) --tag=CXX $(AM_LIBTOOLFLAGS) \
$(LIBTOOLFLAGS) --mode=link $(CXXLD) $(AM_CXXFLAGS) \
$(CXXFLAGS) $(AM_LDFLAGS) $(LDFLAGS) -o $@
AM_V_CXXLD = $(am__v_CXXLD_$(V))
am__v_CXXLD_ = $(am__v_CXXLD_$(AM_DEFAULT_VERBOSITY))
am__v_CXXLD_0 = @echo " CXXLD " $@;
am__v_CXXLD_1 =
SOURCES = $(libnm_la_SOURCES)
DIST_SOURCES = $(libnm_la_SOURCES)
am__can_run_installinfo = \
case $$AM_UPDATE_INFO_DIR in \
n|no|NO) false;; \
*) (install-info --version) >/dev/null 2>&1;; \
esac
am__vpath_adj_setup = srcdirstrip=`echo "$(srcdir)" | sed 's|.|.|g'`;
am__vpath_adj = case $$p in \
$(srcdir)/*) f=`echo "$$p" | sed "s|^$$srcdirstrip/||"`;; \
*) f=$$p;; \
esac;
am__strip_dir = f=`echo $$p | sed -e 's|^.*/||'`;
am__install_max = 40
am__nobase_strip_setup = \
srcdirstrip=`echo "$(srcdir)" | sed 's/[].[^$$\\*|]/\\\\&/g'`
am__nobase_strip = \
for p in $$list; do echo "$$p"; done | sed -e "s|$$srcdirstrip/||"
am__nobase_list = $(am__nobase_strip_setup); \
for p in $$list; do echo "$$p $$p"; done | \
sed "s| $$srcdirstrip/| |;"' / .*\//!s/ .*/ ./; s,\( .*\)/[^/]*$$,\1,' | \
$(AWK) 'BEGIN { files["."] = "" } { files[$$2] = files[$$2] " " $$1; \
if (++n[$$2] == $(am__install_max)) \
{ print $$2, files[$$2]; n[$$2] = 0; files[$$2] = "" } } \
END { for (dir in files) print dir, files[dir] }'
am__base_list = \
sed '$$!N;$$!N;$$!N;$$!N;$$!N;$$!N;$$!N;s/\n/ /g' | \
sed '$$!N;$$!N;$$!N;$$!N;s/\n/ /g'
am__uninstall_files_from_dir = { \
test -z "$$files" \
|| { test ! -d "$$dir" && test ! -f "$$dir" && test ! -r "$$dir"; } \
|| { echo " ( cd '$$dir' && rm -f" $$files ")"; \
$(am__cd) "$$dir" && rm -f $$files; }; \
}
am__installdirs = "$(DESTDIR)$(includedir)"
HEADERS = $(include_HEADERS)
am__extra_recursive_targets = python-recursive
am__tagged_files = $(HEADERS) $(SOURCES) $(TAGS_FILES) $(LISP)
# Read a list of newline-separated strings from the standard input,
# and print each of them once, without duplicates. Input order is
# *not* preserved.
am__uniquify_input = $(AWK) '\
BEGIN { nonempty = 0; } \
{ items[$$0] = 1; nonempty = 1; } \
END { if (nonempty) { for (i in items) print i; }; } \
'
# Make sure the list of sources is unique. This is necessary because,
# e.g., the same source file might be shared among _SOURCES variables
# for different programs/libraries.
am__define_uniq_tagged_files = \
list='$(am__tagged_files)'; \
unique=`for i in $$list; do \
if test -f "$$i"; then echo $$i; else echo $(srcdir)/$$i; fi; \
done | $(am__uniquify_input)`
am__DIST_COMMON = $(srcdir)/Makefile.in $(top_srcdir)/depcomp
DISTFILES = $(DIST_COMMON) $(DIST_SOURCES) $(TEXINFOS) $(EXTRA_DIST)
ACLOCAL = ${SHELL} '/home/igv/Hepforge/npstat/trunk/missing' aclocal-1.16
AMTAR = $${TAR-tar}
AM_DEFAULT_VERBOSITY = 1
AR = ar
AUTOCONF = ${SHELL} '/home/igv/Hepforge/npstat/trunk/missing' autoconf
AUTOHEADER = ${SHELL} '/home/igv/Hepforge/npstat/trunk/missing' autoheader
AUTOMAKE = ${SHELL} '/home/igv/Hepforge/npstat/trunk/missing' automake-1.16
AWK = mawk
CC = gcc
CCDEPMODE = depmode=gcc3
CFLAGS = -g -O2
CPPFLAGS =
CSCOPE = cscope
CTAGS = ctags
CXX = g++
CXXCPP = g++ -E
CXXDEPMODE = depmode=gcc3
CXXFLAGS = -std=c++11 -O3 -Wall -W -Werror
CYGPATH_W = echo
DEFS = -DPACKAGE_NAME=\"npstat\" -DPACKAGE_TARNAME=\"npstat\" -DPACKAGE_VERSION=\"5.9.0\" -DPACKAGE_STRING=\"npstat\ 5.9.0\" -DPACKAGE_BUGREPORT=\"\" -DPACKAGE_URL=\"\" -DPACKAGE=\"npstat\" -DVERSION=\"5.9.0\" -DHAVE_STDIO_H=1 -DHAVE_STDLIB_H=1 -DHAVE_STRING_H=1 -DHAVE_INTTYPES_H=1 -DHAVE_STDINT_H=1 -DHAVE_STRINGS_H=1 -DHAVE_SYS_STAT_H=1 -DHAVE_SYS_TYPES_H=1 -DHAVE_UNISTD_H=1 -DSTDC_HEADERS=1 -DHAVE_DLFCN_H=1 -DLT_OBJDIR=\".libs/\"
DEPDIR = .deps
DEPS_CFLAGS = -I/usr/local/include
DEPS_LIBS = -L/usr/local/lib -lfftw3 -lgeners -lkstest
DLLTOOL = false
DSYMUTIL =
DUMPBIN =
ECHO_C =
ECHO_N = -n
ECHO_T =
EGREP = /bin/grep -E
ETAGS = etags
EXEEXT =
F77 = g77
FFLAGS = -g -O2
FGREP = /bin/grep -F
FLIBS = -L/usr/lib/gcc/x86_64-linux-gnu/11 -L/usr/lib/gcc/x86_64-linux-gnu/11/../../../x86_64-linux-gnu -L/usr/lib/gcc/x86_64-linux-gnu/11/../../../../lib -L/lib/x86_64-linux-gnu -L/lib/../lib -L/usr/lib/x86_64-linux-gnu -L/usr/lib/../lib -L/usr/lib/gcc/x86_64-linux-gnu/11/../../.. -lgfortran -lm -lquadmath
GREP = /bin/grep
INSTALL = /bin/install -c
INSTALL_DATA = ${INSTALL} -m 644
INSTALL_PROGRAM = ${INSTALL}
INSTALL_SCRIPT = ${INSTALL}
INSTALL_STRIP_PROGRAM = $(install_sh) -c -s
LD = /bin/ld -m elf_x86_64
LDFLAGS =
LIBOBJS =
LIBS =
LIBTOOL = $(SHELL) $(top_builddir)/libtool
LIPO =
LN_S = ln -s
LTLIBOBJS =
LT_SYS_LIBRARY_PATH =
MAKEINFO = ${SHELL} '/home/igv/Hepforge/npstat/trunk/missing' makeinfo
MANIFEST_TOOL = :
MKDIR_P = /bin/mkdir -p
NM = /bin/nm -B
NMEDIT =
OBJDUMP = objdump
OBJEXT = o
OTOOL =
OTOOL64 =
PACKAGE = npstat
PACKAGE_BUGREPORT =
PACKAGE_NAME = npstat
PACKAGE_STRING = npstat 5.9.0
PACKAGE_TARNAME = npstat
PACKAGE_URL =
PACKAGE_VERSION = 5.9.0
PATH_SEPARATOR = :
PKG_CONFIG = /bin/pkg-config
PKG_CONFIG_LIBDIR =
PKG_CONFIG_PATH = /usr/local/lib/pkgconfig
RANLIB = ranlib
SED = /bin/sed
SET_MAKE =
SHELL = /bin/bash
STRIP = strip
VERSION = 5.9.0
abs_builddir = /home/igv/Hepforge/npstat/trunk/npstat/nm
abs_srcdir = /home/igv/Hepforge/npstat/trunk/npstat/nm
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/nm
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 = libnm.la
libnm_la_SOURCES = ArrayShape.cc ArrayRange.cc SpecialFunctions.cc \
ConvolutionEngine1D.cc EquidistantSequence.cc GaussHermiteQuadrature.cc \
GaussLegendreQuadrature.cc MathUtils.cc OrthoPoly1D.cc GridAxis.cc \
rectangleQuadrature.cc LinInterpolatedTable1D.cc ScanExtremum1D.cc \
bilinearSection.cc ConvolutionEngineND.cc FourierImage.cc SvdMethod.cc \
binomialCoefficient.cc UniformAxis.cc ArrayNDScanner.cc DualAxis.cc \
DiscreteBernsteinPoly1D.cc definiteIntegrals.cc EigenMethod.cc \
goldenSectionSearch.cc timestamp.cc OrthoPolyMethod.cc ContOrthoPoly1D.cc \
lapack_interface.cc AbsClassicalOrthoPoly1D.cc ClassicalOrthoPolys1D.cc \
matrixIndexPairs.cc truncatedInverseSqrt.cc FejerQuadrature.cc \
StorablePolySeries1D.cc SemiInfGaussianQuadrature.cc Gauss1DQuadrature.cc \
HeatEq1DNeumannBoundary.cc performSchultzIteration.cc RecurrenceCoeffs.cc \
GaussLegendreQuadratureQ.cc GaussLegendreQuadrature2D.cc Poly1D.cc \
ScalableClassicalOrthoPoly1D.cc RectangleQuadrature1D.cc findPeak2D.cc \
sineTransformMatrix.cc
include_HEADERS = AbsArrayProjector.hh \
AbsClassicalOrthoPoly1D.hh \
AbsClassicalOrthoPoly1D.icc \
absDifference.hh \
AbsIntervalQuadrature1D.hh \
AbsMultivariateFunctor.hh \
AbsVisitor.hh \
allocators.hh \
areAllElementsUnique.hh \
ArrayND.hh \
ArrayND.icc \
ArrayNDScanner.hh \
ArrayRange.hh \
ArrayShape.hh \
bilinearSection.hh \
BindKernel.hh \
binomialCoefficient.hh \
BoundaryInclusion.hh \
BoxND.hh \
BoxND.icc \
BoxNDScanner.hh \
BoxNDScanner.icc \
cdKernelSensitivityMatrix.hh \
cdKernelSensitivityMatrix.icc \
CircularMapper1d.hh \
ClassicalOrthoPoly1DFromWeight.hh \
ClassicalOrthoPoly1DFromWeight.icc \
ClassicalOrthoPolys1D.hh \
closeWithinTolerance.hh \
CompareByIndex.hh \
ComplexComparesAbs.hh \
ComplexComparesFalse.hh \
ConstSubscriptMap.hh \
ContOrthoPoly1D.hh \
ContOrthoPoly1D.icc \
ConvolutionDensity1D.hh \
ConvolutionDensity1D.icc \
ConvolutionEngine1D.hh \
ConvolutionEngine1D.icc \
ConvolutionEngineND.hh \
ConvolutionEngineND.icc \
coordAndWeight.hh \
CoordinateSelector.hh \
definiteIntegrals.hh \
DiscreteBernsteinPoly1D.hh \
discretizedDistance.hh \
discretizedDistance.icc \
DualAxis.hh \
EigenMethod.hh \
EquidistantSequence.hh \
ExpMapper1d.hh \
fcnOrConst.hh \
FejerQuadrature.hh \
FejerQuadrature.icc \
fillArrayCentersPreservingAreas.hh \
findPeak2D.hh \
findRootInLogSpace.hh \
findRootInLogSpace.icc \
findRootNewtonRaphson.hh \
findRootNewtonRaphson.icc \
findRootUsingBisections.hh \
findRootUsingBisections.icc \
float128IO.hh \
FourierImage.hh \
Gauss1DQuadrature.hh \
GaussHermiteQuadrature.hh \
GaussHermiteQuadrature.icc \
GaussianDip.hh \
GaussLegendreQuadrature.hh \
GaussLegendreQuadrature.icc \
GaussLegendreQuadrature2D.hh \
GaussLegendreQuadrature2D.icc \
GaussLegendreQuadratureQ.hh \
GaussLegendreQuadratureQ.icc \
GeneralizedComplex.hh \
goldenSectionSearch.hh \
goldenSectionSearch.icc \
GridAxis.hh \
HeatEq1DNeumannBoundary.hh \
interpolate.hh \
interpolate.icc \
Interval.hh \
Interval.icc \
isMonotonous.hh \
KDTree.hh \
KDTree.icc \
kernelSensitivityMatrix.hh \
kernelSensitivityMatrix.icc \
lapack.h \
lapack_double.h \
lapack_interface.hh \
lapack_interface.icc \
lapack_interface_double.icc \
lapack_interface_ldouble.icc \
lapack_interface_float.icc \
LinearMapper1d.hh \
LinInterpolatedTable1D.hh \
LinInterpolatedTable1D.icc \
LinInterpolatedTableND.hh \
LinInterpolatedTableND.icc \
LogMapper1d.hh \
LongerType.hh \
MathUtils.hh \
MathUtils.icc \
Matrix.hh \
matrixIndexPairs.hh \
Matrix.icc \
MinSearchStatus1D.hh \
MultivariateFunctorScanner.hh \
OrthoPoly1D.hh \
OrthoPoly1D.icc \
OrthoPolyMethod.hh \
OrthoPolyND.hh \
OrthoPolyND.icc \
PairCompare.hh \
performSchultzIteration.hh \
PointDimensionality.hh \
Poly1D.hh \
polyPrivateUtils.hh \
polyPrivateUtils.icc \
PreciseType.hh \
ProperDblFromCmpl.hh \
PtrBufferHandle.hh \
RectangleQuadrature1D.hh \
RectangleQuadrature1D.icc \
Recurrence.hh \
RecurrenceCoeffs.hh \
RecurrenceCoeffs.icc \
RecurrenceCoeffsTrGauss.hh \
RecurrenceCoeffsTrGauss.icc \
rectangleQuadrature.hh \
rescanArray.hh \
rescanArray.icc \
ScanExtremum1D.hh \
ScalableClassicalOrthoPoly1D.hh \
ScalableClassicalOrthoPoly1D.icc \
SemiInfGaussianQuadrature.hh \
SemiInfGaussianQuadrature.icc \
SimpleFunctors.hh \
sineTransformMatrix.hh \
SpecialFunctions.hh \
std_quadmath.hh \
StorablePolySeries1D.hh \
StorablePolySeries1D.icc \
sumOfSquares.hh \
SvdMethod.hh \
timestamp.hh \
Triple.hh \
truncatedInverseSqrt.hh \
- UniformAxis.hh
+ UniformAxis.hh \
+ vectorAsText.hh
EXTRA_DIST = 00README.txt
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/nm/Makefile'; \
$(am__cd) $(top_srcdir) && \
$(AUTOMAKE) --foreign npstat/nm/Makefile
Makefile: $(srcdir)/Makefile.in $(top_builddir)/config.status
@case '$?' in \
*config.status*) \
cd $(top_builddir) && $(MAKE) $(AM_MAKEFLAGS) am--refresh;; \
*) \
echo ' cd $(top_builddir) && $(SHELL) ./config.status $(subdir)/$@ $(am__maybe_remake_depfiles)'; \
cd $(top_builddir) && $(SHELL) ./config.status $(subdir)/$@ $(am__maybe_remake_depfiles);; \
esac;
$(top_builddir)/config.status: $(top_srcdir)/configure $(CONFIG_STATUS_DEPENDENCIES)
cd $(top_builddir) && $(MAKE) $(AM_MAKEFLAGS) am--refresh
$(top_srcdir)/configure: $(am__configure_deps)
cd $(top_builddir) && $(MAKE) $(AM_MAKEFLAGS) am--refresh
$(ACLOCAL_M4): $(am__aclocal_m4_deps)
cd $(top_builddir) && $(MAKE) $(AM_MAKEFLAGS) am--refresh
$(am__aclocal_m4_deps):
clean-noinstLTLIBRARIES:
-test -z "$(noinst_LTLIBRARIES)" || rm -f $(noinst_LTLIBRARIES)
@list='$(noinst_LTLIBRARIES)'; \
locs=`for p in $$list; do echo $$p; done | \
sed 's|^[^/]*$$|.|; s|/[^/]*$$||; s|$$|/so_locations|' | \
sort -u`; \
test -z "$$locs" || { \
echo rm -f $${locs}; \
rm -f $${locs}; \
}
libnm.la: $(libnm_la_OBJECTS) $(libnm_la_DEPENDENCIES) $(EXTRA_libnm_la_DEPENDENCIES)
$(AM_V_CXXLD)$(CXXLINK) $(libnm_la_OBJECTS) $(libnm_la_LIBADD) $(LIBS)
mostlyclean-compile:
-rm -f *.$(OBJEXT)
distclean-compile:
-rm -f *.tab.c
include ./$(DEPDIR)/AbsClassicalOrthoPoly1D.Plo # am--include-marker
include ./$(DEPDIR)/ArrayNDScanner.Plo # am--include-marker
include ./$(DEPDIR)/ArrayRange.Plo # am--include-marker
include ./$(DEPDIR)/ArrayShape.Plo # am--include-marker
include ./$(DEPDIR)/ClassicalOrthoPolys1D.Plo # am--include-marker
include ./$(DEPDIR)/ContOrthoPoly1D.Plo # am--include-marker
include ./$(DEPDIR)/ConvolutionEngine1D.Plo # am--include-marker
include ./$(DEPDIR)/ConvolutionEngineND.Plo # am--include-marker
include ./$(DEPDIR)/DiscreteBernsteinPoly1D.Plo # am--include-marker
include ./$(DEPDIR)/DualAxis.Plo # am--include-marker
include ./$(DEPDIR)/EigenMethod.Plo # am--include-marker
include ./$(DEPDIR)/EquidistantSequence.Plo # am--include-marker
include ./$(DEPDIR)/FejerQuadrature.Plo # am--include-marker
include ./$(DEPDIR)/FourierImage.Plo # am--include-marker
include ./$(DEPDIR)/Gauss1DQuadrature.Plo # am--include-marker
include ./$(DEPDIR)/GaussHermiteQuadrature.Plo # am--include-marker
include ./$(DEPDIR)/GaussLegendreQuadrature.Plo # am--include-marker
include ./$(DEPDIR)/GaussLegendreQuadrature2D.Plo # am--include-marker
include ./$(DEPDIR)/GaussLegendreQuadratureQ.Plo # am--include-marker
include ./$(DEPDIR)/GridAxis.Plo # am--include-marker
include ./$(DEPDIR)/HeatEq1DNeumannBoundary.Plo # am--include-marker
include ./$(DEPDIR)/LinInterpolatedTable1D.Plo # am--include-marker
include ./$(DEPDIR)/MathUtils.Plo # am--include-marker
include ./$(DEPDIR)/OrthoPoly1D.Plo # am--include-marker
include ./$(DEPDIR)/OrthoPolyMethod.Plo # am--include-marker
include ./$(DEPDIR)/Poly1D.Plo # am--include-marker
include ./$(DEPDIR)/RectangleQuadrature1D.Plo # am--include-marker
include ./$(DEPDIR)/RecurrenceCoeffs.Plo # am--include-marker
include ./$(DEPDIR)/ScalableClassicalOrthoPoly1D.Plo # am--include-marker
include ./$(DEPDIR)/ScanExtremum1D.Plo # am--include-marker
include ./$(DEPDIR)/SemiInfGaussianQuadrature.Plo # am--include-marker
include ./$(DEPDIR)/SpecialFunctions.Plo # am--include-marker
include ./$(DEPDIR)/StorablePolySeries1D.Plo # am--include-marker
include ./$(DEPDIR)/SvdMethod.Plo # am--include-marker
include ./$(DEPDIR)/UniformAxis.Plo # am--include-marker
include ./$(DEPDIR)/bilinearSection.Plo # am--include-marker
include ./$(DEPDIR)/binomialCoefficient.Plo # am--include-marker
include ./$(DEPDIR)/definiteIntegrals.Plo # am--include-marker
include ./$(DEPDIR)/findPeak2D.Plo # am--include-marker
include ./$(DEPDIR)/goldenSectionSearch.Plo # am--include-marker
include ./$(DEPDIR)/lapack_interface.Plo # am--include-marker
include ./$(DEPDIR)/matrixIndexPairs.Plo # am--include-marker
include ./$(DEPDIR)/performSchultzIteration.Plo # am--include-marker
include ./$(DEPDIR)/rectangleQuadrature.Plo # am--include-marker
include ./$(DEPDIR)/sineTransformMatrix.Plo # am--include-marker
include ./$(DEPDIR)/timestamp.Plo # am--include-marker
include ./$(DEPDIR)/truncatedInverseSqrt.Plo # am--include-marker
$(am__depfiles_remade):
@$(MKDIR_P) $(@D)
@echo '# dummy' >$@-t && $(am__mv) $@-t $@
am--depfiles: $(am__depfiles_remade)
.cc.o:
$(AM_V_CXX)$(CXXCOMPILE) -MT $@ -MD -MP -MF $(DEPDIR)/$*.Tpo -c -o $@ $<
$(AM_V_at)$(am__mv) $(DEPDIR)/$*.Tpo $(DEPDIR)/$*.Po
# $(AM_V_CXX)source='$<' object='$@' libtool=no \
# DEPDIR=$(DEPDIR) $(CXXDEPMODE) $(depcomp) \
# $(AM_V_CXX_no)$(CXXCOMPILE) -c -o $@ $<
.cc.obj:
$(AM_V_CXX)$(CXXCOMPILE) -MT $@ -MD -MP -MF $(DEPDIR)/$*.Tpo -c -o $@ `$(CYGPATH_W) '$<'`
$(AM_V_at)$(am__mv) $(DEPDIR)/$*.Tpo $(DEPDIR)/$*.Po
# $(AM_V_CXX)source='$<' object='$@' libtool=no \
# DEPDIR=$(DEPDIR) $(CXXDEPMODE) $(depcomp) \
# $(AM_V_CXX_no)$(CXXCOMPILE) -c -o $@ `$(CYGPATH_W) '$<'`
.cc.lo:
$(AM_V_CXX)$(LTCXXCOMPILE) -MT $@ -MD -MP -MF $(DEPDIR)/$*.Tpo -c -o $@ $<
$(AM_V_at)$(am__mv) $(DEPDIR)/$*.Tpo $(DEPDIR)/$*.Plo
# $(AM_V_CXX)source='$<' object='$@' libtool=yes \
# DEPDIR=$(DEPDIR) $(CXXDEPMODE) $(depcomp) \
# $(AM_V_CXX_no)$(LTCXXCOMPILE) -c -o $@ $<
mostlyclean-libtool:
-rm -f *.lo
clean-libtool:
-rm -rf .libs _libs
install-includeHEADERS: $(include_HEADERS)
@$(NORMAL_INSTALL)
@list='$(include_HEADERS)'; test -n "$(includedir)" || list=; \
if test -n "$$list"; then \
echo " $(MKDIR_P) '$(DESTDIR)$(includedir)'"; \
$(MKDIR_P) "$(DESTDIR)$(includedir)" || exit 1; \
fi; \
for p in $$list; do \
if test -f "$$p"; then d=; else d="$(srcdir)/"; fi; \
echo "$$d$$p"; \
done | $(am__base_list) | \
while read files; do \
echo " $(INSTALL_HEADER) $$files '$(DESTDIR)$(includedir)'"; \
$(INSTALL_HEADER) $$files "$(DESTDIR)$(includedir)" || exit $$?; \
done
uninstall-includeHEADERS:
@$(NORMAL_UNINSTALL)
@list='$(include_HEADERS)'; test -n "$(includedir)" || list=; \
files=`for p in $$list; do echo $$p; done | sed -e 's|^.*/||'`; \
dir='$(DESTDIR)$(includedir)'; $(am__uninstall_files_from_dir)
python-local:
ID: $(am__tagged_files)
$(am__define_uniq_tagged_files); mkid -fID $$unique
tags: tags-am
TAGS: tags
tags-am: $(TAGS_DEPENDENCIES) $(am__tagged_files)
set x; \
here=`pwd`; \
$(am__define_uniq_tagged_files); \
shift; \
if test -z "$(ETAGS_ARGS)$$*$$unique"; then :; else \
test -n "$$unique" || unique=$$empty_fix; \
if test $$# -gt 0; then \
$(ETAGS) $(ETAGSFLAGS) $(AM_ETAGSFLAGS) $(ETAGS_ARGS) \
"$$@" $$unique; \
else \
$(ETAGS) $(ETAGSFLAGS) $(AM_ETAGSFLAGS) $(ETAGS_ARGS) \
$$unique; \
fi; \
fi
ctags: ctags-am
CTAGS: ctags
ctags-am: $(TAGS_DEPENDENCIES) $(am__tagged_files)
$(am__define_uniq_tagged_files); \
test -z "$(CTAGS_ARGS)$$unique" \
|| $(CTAGS) $(CTAGSFLAGS) $(AM_CTAGSFLAGS) $(CTAGS_ARGS) \
$$unique
GTAGS:
here=`$(am__cd) $(top_builddir) && pwd` \
&& $(am__cd) $(top_srcdir) \
&& gtags -i $(GTAGS_ARGS) "$$here"
cscopelist: cscopelist-am
cscopelist-am: $(am__tagged_files)
list='$(am__tagged_files)'; \
case "$(srcdir)" in \
[\\/]* | ?:[\\/]*) sdir="$(srcdir)" ;; \
*) sdir=$(subdir)/$(srcdir) ;; \
esac; \
for i in $$list; do \
if test -f "$$i"; then \
echo "$(subdir)/$$i"; \
else \
echo "$$sdir/$$i"; \
fi; \
done >> $(top_builddir)/cscope.files
distclean-tags:
-rm -f TAGS ID GTAGS GRTAGS GSYMS GPATH tags
distdir: $(BUILT_SOURCES)
$(MAKE) $(AM_MAKEFLAGS) distdir-am
distdir-am: $(DISTFILES)
@srcdirstrip=`echo "$(srcdir)" | sed 's/[].[^$$\\*]/\\\\&/g'`; \
topsrcdirstrip=`echo "$(top_srcdir)" | sed 's/[].[^$$\\*]/\\\\&/g'`; \
list='$(DISTFILES)'; \
dist_files=`for file in $$list; do echo $$file; done | \
sed -e "s|^$$srcdirstrip/||;t" \
-e "s|^$$topsrcdirstrip/|$(top_builddir)/|;t"`; \
case $$dist_files in \
*/*) $(MKDIR_P) `echo "$$dist_files" | \
sed '/\//!d;s|^|$(distdir)/|;s,/[^/]*$$,,' | \
sort -u` ;; \
esac; \
for file in $$dist_files; do \
if test -f $$file || test -d $$file; then d=.; else d=$(srcdir); fi; \
if test -d $$d/$$file; then \
dir=`echo "/$$file" | sed -e 's,/[^/]*$$,,'`; \
if test -d "$(distdir)/$$file"; then \
find "$(distdir)/$$file" -type d ! -perm -700 -exec chmod u+rwx {} \;; \
fi; \
if test -d $(srcdir)/$$file && test $$d != $(srcdir); then \
cp -fpR $(srcdir)/$$file "$(distdir)$$dir" || exit 1; \
find "$(distdir)/$$file" -type d ! -perm -700 -exec chmod u+rwx {} \;; \
fi; \
cp -fpR $$d/$$file "$(distdir)$$dir" || exit 1; \
else \
test -f "$(distdir)/$$file" \
|| cp -p $$d/$$file "$(distdir)/$$file" \
|| exit 1; \
fi; \
done
check-am: all-am
check: check-am
all-am: Makefile $(LTLIBRARIES) $(HEADERS)
installdirs:
for dir in "$(DESTDIR)$(includedir)"; do \
test -z "$$dir" || $(MKDIR_P) "$$dir"; \
done
install: install-am
install-exec: install-exec-am
install-data: install-data-am
uninstall: uninstall-am
install-am: all-am
@$(MAKE) $(AM_MAKEFLAGS) install-exec-am install-data-am
installcheck: installcheck-am
install-strip:
if test -z '$(STRIP)'; then \
$(MAKE) $(AM_MAKEFLAGS) INSTALL_PROGRAM="$(INSTALL_STRIP_PROGRAM)" \
install_sh_PROGRAM="$(INSTALL_STRIP_PROGRAM)" INSTALL_STRIP_FLAG=-s \
install; \
else \
$(MAKE) $(AM_MAKEFLAGS) INSTALL_PROGRAM="$(INSTALL_STRIP_PROGRAM)" \
install_sh_PROGRAM="$(INSTALL_STRIP_PROGRAM)" INSTALL_STRIP_FLAG=-s \
"INSTALL_PROGRAM_ENV=STRIPPROG='$(STRIP)'" install; \
fi
mostlyclean-generic:
clean-generic:
distclean-generic:
-test -z "$(CONFIG_CLEAN_FILES)" || rm -f $(CONFIG_CLEAN_FILES)
-test . = "$(srcdir)" || test -z "$(CONFIG_CLEAN_VPATH_FILES)" || rm -f $(CONFIG_CLEAN_VPATH_FILES)
maintainer-clean-generic:
@echo "This command is intended for maintainers to use"
@echo "it deletes files that may require special tools to rebuild."
clean: clean-am
clean-am: clean-generic clean-libtool clean-noinstLTLIBRARIES \
mostlyclean-am
distclean: distclean-am
-rm -f ./$(DEPDIR)/AbsClassicalOrthoPoly1D.Plo
-rm -f ./$(DEPDIR)/ArrayNDScanner.Plo
-rm -f ./$(DEPDIR)/ArrayRange.Plo
-rm -f ./$(DEPDIR)/ArrayShape.Plo
-rm -f ./$(DEPDIR)/ClassicalOrthoPolys1D.Plo
-rm -f ./$(DEPDIR)/ContOrthoPoly1D.Plo
-rm -f ./$(DEPDIR)/ConvolutionEngine1D.Plo
-rm -f ./$(DEPDIR)/ConvolutionEngineND.Plo
-rm -f ./$(DEPDIR)/DiscreteBernsteinPoly1D.Plo
-rm -f ./$(DEPDIR)/DualAxis.Plo
-rm -f ./$(DEPDIR)/EigenMethod.Plo
-rm -f ./$(DEPDIR)/EquidistantSequence.Plo
-rm -f ./$(DEPDIR)/FejerQuadrature.Plo
-rm -f ./$(DEPDIR)/FourierImage.Plo
-rm -f ./$(DEPDIR)/Gauss1DQuadrature.Plo
-rm -f ./$(DEPDIR)/GaussHermiteQuadrature.Plo
-rm -f ./$(DEPDIR)/GaussLegendreQuadrature.Plo
-rm -f ./$(DEPDIR)/GaussLegendreQuadrature2D.Plo
-rm -f ./$(DEPDIR)/GaussLegendreQuadratureQ.Plo
-rm -f ./$(DEPDIR)/GridAxis.Plo
-rm -f ./$(DEPDIR)/HeatEq1DNeumannBoundary.Plo
-rm -f ./$(DEPDIR)/LinInterpolatedTable1D.Plo
-rm -f ./$(DEPDIR)/MathUtils.Plo
-rm -f ./$(DEPDIR)/OrthoPoly1D.Plo
-rm -f ./$(DEPDIR)/OrthoPolyMethod.Plo
-rm -f ./$(DEPDIR)/Poly1D.Plo
-rm -f ./$(DEPDIR)/RectangleQuadrature1D.Plo
-rm -f ./$(DEPDIR)/RecurrenceCoeffs.Plo
-rm -f ./$(DEPDIR)/ScalableClassicalOrthoPoly1D.Plo
-rm -f ./$(DEPDIR)/ScanExtremum1D.Plo
-rm -f ./$(DEPDIR)/SemiInfGaussianQuadrature.Plo
-rm -f ./$(DEPDIR)/SpecialFunctions.Plo
-rm -f ./$(DEPDIR)/StorablePolySeries1D.Plo
-rm -f ./$(DEPDIR)/SvdMethod.Plo
-rm -f ./$(DEPDIR)/UniformAxis.Plo
-rm -f ./$(DEPDIR)/bilinearSection.Plo
-rm -f ./$(DEPDIR)/binomialCoefficient.Plo
-rm -f ./$(DEPDIR)/definiteIntegrals.Plo
-rm -f ./$(DEPDIR)/findPeak2D.Plo
-rm -f ./$(DEPDIR)/goldenSectionSearch.Plo
-rm -f ./$(DEPDIR)/lapack_interface.Plo
-rm -f ./$(DEPDIR)/matrixIndexPairs.Plo
-rm -f ./$(DEPDIR)/performSchultzIteration.Plo
-rm -f ./$(DEPDIR)/rectangleQuadrature.Plo
-rm -f ./$(DEPDIR)/sineTransformMatrix.Plo
-rm -f ./$(DEPDIR)/timestamp.Plo
-rm -f ./$(DEPDIR)/truncatedInverseSqrt.Plo
-rm -f Makefile
distclean-am: clean-am distclean-compile distclean-generic \
distclean-tags
dvi: dvi-am
dvi-am:
html: html-am
html-am:
info: info-am
info-am:
install-data-am: install-includeHEADERS
install-dvi: install-dvi-am
install-dvi-am:
install-exec-am:
install-html: install-html-am
install-html-am:
install-info: install-info-am
install-info-am:
install-man:
install-pdf: install-pdf-am
install-pdf-am:
install-ps: install-ps-am
install-ps-am:
installcheck-am:
maintainer-clean: maintainer-clean-am
-rm -f ./$(DEPDIR)/AbsClassicalOrthoPoly1D.Plo
-rm -f ./$(DEPDIR)/ArrayNDScanner.Plo
-rm -f ./$(DEPDIR)/ArrayRange.Plo
-rm -f ./$(DEPDIR)/ArrayShape.Plo
-rm -f ./$(DEPDIR)/ClassicalOrthoPolys1D.Plo
-rm -f ./$(DEPDIR)/ContOrthoPoly1D.Plo
-rm -f ./$(DEPDIR)/ConvolutionEngine1D.Plo
-rm -f ./$(DEPDIR)/ConvolutionEngineND.Plo
-rm -f ./$(DEPDIR)/DiscreteBernsteinPoly1D.Plo
-rm -f ./$(DEPDIR)/DualAxis.Plo
-rm -f ./$(DEPDIR)/EigenMethod.Plo
-rm -f ./$(DEPDIR)/EquidistantSequence.Plo
-rm -f ./$(DEPDIR)/FejerQuadrature.Plo
-rm -f ./$(DEPDIR)/FourierImage.Plo
-rm -f ./$(DEPDIR)/Gauss1DQuadrature.Plo
-rm -f ./$(DEPDIR)/GaussHermiteQuadrature.Plo
-rm -f ./$(DEPDIR)/GaussLegendreQuadrature.Plo
-rm -f ./$(DEPDIR)/GaussLegendreQuadrature2D.Plo
-rm -f ./$(DEPDIR)/GaussLegendreQuadratureQ.Plo
-rm -f ./$(DEPDIR)/GridAxis.Plo
-rm -f ./$(DEPDIR)/HeatEq1DNeumannBoundary.Plo
-rm -f ./$(DEPDIR)/LinInterpolatedTable1D.Plo
-rm -f ./$(DEPDIR)/MathUtils.Plo
-rm -f ./$(DEPDIR)/OrthoPoly1D.Plo
-rm -f ./$(DEPDIR)/OrthoPolyMethod.Plo
-rm -f ./$(DEPDIR)/Poly1D.Plo
-rm -f ./$(DEPDIR)/RectangleQuadrature1D.Plo
-rm -f ./$(DEPDIR)/RecurrenceCoeffs.Plo
-rm -f ./$(DEPDIR)/ScalableClassicalOrthoPoly1D.Plo
-rm -f ./$(DEPDIR)/ScanExtremum1D.Plo
-rm -f ./$(DEPDIR)/SemiInfGaussianQuadrature.Plo
-rm -f ./$(DEPDIR)/SpecialFunctions.Plo
-rm -f ./$(DEPDIR)/StorablePolySeries1D.Plo
-rm -f ./$(DEPDIR)/SvdMethod.Plo
-rm -f ./$(DEPDIR)/UniformAxis.Plo
-rm -f ./$(DEPDIR)/bilinearSection.Plo
-rm -f ./$(DEPDIR)/binomialCoefficient.Plo
-rm -f ./$(DEPDIR)/definiteIntegrals.Plo
-rm -f ./$(DEPDIR)/findPeak2D.Plo
-rm -f ./$(DEPDIR)/goldenSectionSearch.Plo
-rm -f ./$(DEPDIR)/lapack_interface.Plo
-rm -f ./$(DEPDIR)/matrixIndexPairs.Plo
-rm -f ./$(DEPDIR)/performSchultzIteration.Plo
-rm -f ./$(DEPDIR)/rectangleQuadrature.Plo
-rm -f ./$(DEPDIR)/sineTransformMatrix.Plo
-rm -f ./$(DEPDIR)/timestamp.Plo
-rm -f ./$(DEPDIR)/truncatedInverseSqrt.Plo
-rm -f Makefile
maintainer-clean-am: distclean-am maintainer-clean-generic
mostlyclean: mostlyclean-am
mostlyclean-am: mostlyclean-compile mostlyclean-generic \
mostlyclean-libtool
pdf: pdf-am
pdf-am:
ps: ps-am
ps-am:
python: python-am
python-am: python-local
uninstall-am: uninstall-includeHEADERS
.MAKE: install-am install-strip
.PHONY: CTAGS GTAGS TAGS all all-am am--depfiles check check-am clean \
clean-generic clean-libtool clean-noinstLTLIBRARIES \
cscopelist-am ctags ctags-am distclean distclean-compile \
distclean-generic distclean-libtool distclean-tags distdir dvi \
dvi-am html html-am info info-am install install-am \
install-data install-data-am install-dvi install-dvi-am \
install-exec install-exec-am install-html install-html-am \
install-includeHEADERS install-info install-info-am \
install-man install-pdf install-pdf-am install-ps \
install-ps-am install-strip installcheck installcheck-am \
installdirs maintainer-clean maintainer-clean-generic \
mostlyclean mostlyclean-compile mostlyclean-generic \
mostlyclean-libtool pdf pdf-am ps ps-am python-am python-local \
tags tags-am uninstall uninstall-am uninstall-includeHEADERS
.PRECIOUS: Makefile
# Tell versions [3.59,3.63) of GNU make to not export all variables.
# Otherwise a system limit (for SysV at least) may be exceeded.
.NOEXPORT:
Index: trunk/npstat/nm/Makefile.am
===================================================================
--- trunk/npstat/nm/Makefile.am (revision 876)
+++ trunk/npstat/nm/Makefile.am (revision 877)
@@ -1,174 +1,175 @@
AM_CPPFLAGS = -I@top_srcdir@/ $(DEPS_CFLAGS)
noinst_LTLIBRARIES = libnm.la
libnm_la_SOURCES = ArrayShape.cc ArrayRange.cc SpecialFunctions.cc \
ConvolutionEngine1D.cc EquidistantSequence.cc GaussHermiteQuadrature.cc \
GaussLegendreQuadrature.cc MathUtils.cc OrthoPoly1D.cc GridAxis.cc \
rectangleQuadrature.cc LinInterpolatedTable1D.cc ScanExtremum1D.cc \
bilinearSection.cc ConvolutionEngineND.cc FourierImage.cc SvdMethod.cc \
binomialCoefficient.cc UniformAxis.cc ArrayNDScanner.cc DualAxis.cc \
DiscreteBernsteinPoly1D.cc definiteIntegrals.cc EigenMethod.cc \
goldenSectionSearch.cc timestamp.cc OrthoPolyMethod.cc ContOrthoPoly1D.cc \
lapack_interface.cc AbsClassicalOrthoPoly1D.cc ClassicalOrthoPolys1D.cc \
matrixIndexPairs.cc truncatedInverseSqrt.cc FejerQuadrature.cc \
StorablePolySeries1D.cc SemiInfGaussianQuadrature.cc Gauss1DQuadrature.cc \
HeatEq1DNeumannBoundary.cc performSchultzIteration.cc RecurrenceCoeffs.cc \
GaussLegendreQuadratureQ.cc GaussLegendreQuadrature2D.cc Poly1D.cc \
ScalableClassicalOrthoPoly1D.cc RectangleQuadrature1D.cc findPeak2D.cc \
sineTransformMatrix.cc
includedir = ${prefix}/include/npstat/nm
include_HEADERS = AbsArrayProjector.hh \
AbsClassicalOrthoPoly1D.hh \
AbsClassicalOrthoPoly1D.icc \
absDifference.hh \
AbsIntervalQuadrature1D.hh \
AbsMultivariateFunctor.hh \
AbsVisitor.hh \
allocators.hh \
areAllElementsUnique.hh \
ArrayND.hh \
ArrayND.icc \
ArrayNDScanner.hh \
ArrayRange.hh \
ArrayShape.hh \
bilinearSection.hh \
BindKernel.hh \
binomialCoefficient.hh \
BoundaryInclusion.hh \
BoxND.hh \
BoxND.icc \
BoxNDScanner.hh \
BoxNDScanner.icc \
cdKernelSensitivityMatrix.hh \
cdKernelSensitivityMatrix.icc \
CircularMapper1d.hh \
ClassicalOrthoPoly1DFromWeight.hh \
ClassicalOrthoPoly1DFromWeight.icc \
ClassicalOrthoPolys1D.hh \
closeWithinTolerance.hh \
CompareByIndex.hh \
ComplexComparesAbs.hh \
ComplexComparesFalse.hh \
ConstSubscriptMap.hh \
ContOrthoPoly1D.hh \
ContOrthoPoly1D.icc \
ConvolutionDensity1D.hh \
ConvolutionDensity1D.icc \
ConvolutionEngine1D.hh \
ConvolutionEngine1D.icc \
ConvolutionEngineND.hh \
ConvolutionEngineND.icc \
coordAndWeight.hh \
CoordinateSelector.hh \
definiteIntegrals.hh \
DiscreteBernsteinPoly1D.hh \
discretizedDistance.hh \
discretizedDistance.icc \
DualAxis.hh \
EigenMethod.hh \
EquidistantSequence.hh \
ExpMapper1d.hh \
fcnOrConst.hh \
FejerQuadrature.hh \
FejerQuadrature.icc \
fillArrayCentersPreservingAreas.hh \
findPeak2D.hh \
findRootInLogSpace.hh \
findRootInLogSpace.icc \
findRootNewtonRaphson.hh \
findRootNewtonRaphson.icc \
findRootUsingBisections.hh \
findRootUsingBisections.icc \
float128IO.hh \
FourierImage.hh \
Gauss1DQuadrature.hh \
GaussHermiteQuadrature.hh \
GaussHermiteQuadrature.icc \
GaussianDip.hh \
GaussLegendreQuadrature.hh \
GaussLegendreQuadrature.icc \
GaussLegendreQuadrature2D.hh \
GaussLegendreQuadrature2D.icc \
GaussLegendreQuadratureQ.hh \
GaussLegendreQuadratureQ.icc \
GeneralizedComplex.hh \
goldenSectionSearch.hh \
goldenSectionSearch.icc \
GridAxis.hh \
HeatEq1DNeumannBoundary.hh \
interpolate.hh \
interpolate.icc \
Interval.hh \
Interval.icc \
isMonotonous.hh \
KDTree.hh \
KDTree.icc \
kernelSensitivityMatrix.hh \
kernelSensitivityMatrix.icc \
lapack.h \
lapack_double.h \
lapack_interface.hh \
lapack_interface.icc \
lapack_interface_double.icc \
lapack_interface_ldouble.icc \
lapack_interface_float.icc \
LinearMapper1d.hh \
LinInterpolatedTable1D.hh \
LinInterpolatedTable1D.icc \
LinInterpolatedTableND.hh \
LinInterpolatedTableND.icc \
LogMapper1d.hh \
LongerType.hh \
MathUtils.hh \
MathUtils.icc \
Matrix.hh \
matrixIndexPairs.hh \
Matrix.icc \
MinSearchStatus1D.hh \
MultivariateFunctorScanner.hh \
OrthoPoly1D.hh \
OrthoPoly1D.icc \
OrthoPolyMethod.hh \
OrthoPolyND.hh \
OrthoPolyND.icc \
PairCompare.hh \
performSchultzIteration.hh \
PointDimensionality.hh \
Poly1D.hh \
polyPrivateUtils.hh \
polyPrivateUtils.icc \
PreciseType.hh \
ProperDblFromCmpl.hh \
PtrBufferHandle.hh \
RectangleQuadrature1D.hh \
RectangleQuadrature1D.icc \
Recurrence.hh \
RecurrenceCoeffs.hh \
RecurrenceCoeffs.icc \
RecurrenceCoeffsTrGauss.hh \
RecurrenceCoeffsTrGauss.icc \
rectangleQuadrature.hh \
rescanArray.hh \
rescanArray.icc \
ScanExtremum1D.hh \
ScalableClassicalOrthoPoly1D.hh \
ScalableClassicalOrthoPoly1D.icc \
SemiInfGaussianQuadrature.hh \
SemiInfGaussianQuadrature.icc \
SimpleFunctors.hh \
sineTransformMatrix.hh \
SpecialFunctions.hh \
std_quadmath.hh \
StorablePolySeries1D.hh \
StorablePolySeries1D.icc \
sumOfSquares.hh \
SvdMethod.hh \
timestamp.hh \
Triple.hh \
truncatedInverseSqrt.hh \
- UniformAxis.hh
+ UniformAxis.hh \
+ vectorAsText.hh
EXTRA_DIST = 00README.txt
Index: trunk/npstat/nm/Makefile.in
===================================================================
--- trunk/npstat/nm/Makefile.in (revision 876)
+++ trunk/npstat/nm/Makefile.in (revision 877)
@@ -1,1027 +1,1028 @@
# Makefile.in generated by automake 1.16.5 from Makefile.am.
# @configure_input@
# Copyright (C) 1994-2021 Free Software Foundation, Inc.
# This Makefile.in is free software; the Free Software Foundation
# gives unlimited permission to copy and/or distribute it,
# with or without modifications, as long as this notice is preserved.
# This program is distributed in the hope that it will be useful,
# but WITHOUT ANY WARRANTY, to the extent permitted by law; without
# even the implied warranty of MERCHANTABILITY or FITNESS FOR A
# PARTICULAR PURPOSE.
@SET_MAKE@
VPATH = @srcdir@
am__is_gnu_make = { \
if test -z '$(MAKELEVEL)'; then \
false; \
elif test -n '$(MAKE_HOST)'; then \
true; \
elif test -n '$(MAKE_VERSION)' && test -n '$(CURDIR)'; then \
true; \
else \
false; \
fi; \
}
am__make_running_with_option = \
case $${target_option-} in \
?) ;; \
*) echo "am__make_running_with_option: internal error: invalid" \
"target option '$${target_option-}' specified" >&2; \
exit 1;; \
esac; \
has_opt=no; \
sane_makeflags=$$MAKEFLAGS; \
if $(am__is_gnu_make); then \
sane_makeflags=$$MFLAGS; \
else \
case $$MAKEFLAGS in \
*\\[\ \ ]*) \
bs=\\; \
sane_makeflags=`printf '%s\n' "$$MAKEFLAGS" \
| sed "s/$$bs$$bs[$$bs $$bs ]*//g"`;; \
esac; \
fi; \
skip_next=no; \
strip_trailopt () \
{ \
flg=`printf '%s\n' "$$flg" | sed "s/$$1.*$$//"`; \
}; \
for flg in $$sane_makeflags; do \
test $$skip_next = yes && { skip_next=no; continue; }; \
case $$flg in \
*=*|--*) continue;; \
-*I) strip_trailopt 'I'; skip_next=yes;; \
-*I?*) strip_trailopt 'I';; \
-*O) strip_trailopt 'O'; skip_next=yes;; \
-*O?*) strip_trailopt 'O';; \
-*l) strip_trailopt 'l'; skip_next=yes;; \
-*l?*) strip_trailopt 'l';; \
-[dEDm]) skip_next=yes;; \
-[JT]) skip_next=yes;; \
esac; \
case $$flg in \
*$$target_option*) has_opt=yes; break;; \
esac; \
done; \
test $$has_opt = yes
am__make_dryrun = (target_option=n; $(am__make_running_with_option))
am__make_keepgoing = (target_option=k; $(am__make_running_with_option))
pkgdatadir = $(datadir)/@PACKAGE@
pkgincludedir = $(includedir)/@PACKAGE@
pkglibdir = $(libdir)/@PACKAGE@
pkglibexecdir = $(libexecdir)/@PACKAGE@
am__cd = CDPATH="$${ZSH_VERSION+.}$(PATH_SEPARATOR)" && cd
install_sh_DATA = $(install_sh) -c -m 644
install_sh_PROGRAM = $(install_sh) -c
install_sh_SCRIPT = $(install_sh) -c
INSTALL_HEADER = $(INSTALL_DATA)
transform = $(program_transform_name)
NORMAL_INSTALL = :
PRE_INSTALL = :
POST_INSTALL = :
NORMAL_UNINSTALL = :
PRE_UNINSTALL = :
POST_UNINSTALL = :
build_triplet = @build@
host_triplet = @host@
subdir = npstat/nm
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)
libnm_la_LIBADD =
am_libnm_la_OBJECTS = ArrayShape.lo ArrayRange.lo SpecialFunctions.lo \
ConvolutionEngine1D.lo EquidistantSequence.lo \
GaussHermiteQuadrature.lo GaussLegendreQuadrature.lo \
MathUtils.lo OrthoPoly1D.lo GridAxis.lo rectangleQuadrature.lo \
LinInterpolatedTable1D.lo ScanExtremum1D.lo bilinearSection.lo \
ConvolutionEngineND.lo FourierImage.lo SvdMethod.lo \
binomialCoefficient.lo UniformAxis.lo ArrayNDScanner.lo \
DualAxis.lo DiscreteBernsteinPoly1D.lo definiteIntegrals.lo \
EigenMethod.lo goldenSectionSearch.lo timestamp.lo \
OrthoPolyMethod.lo ContOrthoPoly1D.lo lapack_interface.lo \
AbsClassicalOrthoPoly1D.lo ClassicalOrthoPolys1D.lo \
matrixIndexPairs.lo truncatedInverseSqrt.lo FejerQuadrature.lo \
StorablePolySeries1D.lo SemiInfGaussianQuadrature.lo \
Gauss1DQuadrature.lo HeatEq1DNeumannBoundary.lo \
performSchultzIteration.lo RecurrenceCoeffs.lo \
GaussLegendreQuadratureQ.lo GaussLegendreQuadrature2D.lo \
Poly1D.lo ScalableClassicalOrthoPoly1D.lo \
RectangleQuadrature1D.lo findPeak2D.lo sineTransformMatrix.lo
libnm_la_OBJECTS = $(am_libnm_la_OBJECTS)
AM_V_lt = $(am__v_lt_@AM_V@)
am__v_lt_ = $(am__v_lt_@AM_DEFAULT_V@)
am__v_lt_0 = --silent
am__v_lt_1 =
AM_V_P = $(am__v_P_@AM_V@)
am__v_P_ = $(am__v_P_@AM_DEFAULT_V@)
am__v_P_0 = false
am__v_P_1 = :
AM_V_GEN = $(am__v_GEN_@AM_V@)
am__v_GEN_ = $(am__v_GEN_@AM_DEFAULT_V@)
am__v_GEN_0 = @echo " GEN " $@;
am__v_GEN_1 =
AM_V_at = $(am__v_at_@AM_V@)
am__v_at_ = $(am__v_at_@AM_DEFAULT_V@)
am__v_at_0 = @
am__v_at_1 =
DEFAULT_INCLUDES = -I.@am__isrc@
depcomp = $(SHELL) $(top_srcdir)/depcomp
am__maybe_remake_depfiles = depfiles
am__depfiles_remade = ./$(DEPDIR)/AbsClassicalOrthoPoly1D.Plo \
./$(DEPDIR)/ArrayNDScanner.Plo ./$(DEPDIR)/ArrayRange.Plo \
./$(DEPDIR)/ArrayShape.Plo \
./$(DEPDIR)/ClassicalOrthoPolys1D.Plo \
./$(DEPDIR)/ContOrthoPoly1D.Plo \
./$(DEPDIR)/ConvolutionEngine1D.Plo \
./$(DEPDIR)/ConvolutionEngineND.Plo \
./$(DEPDIR)/DiscreteBernsteinPoly1D.Plo \
./$(DEPDIR)/DualAxis.Plo ./$(DEPDIR)/EigenMethod.Plo \
./$(DEPDIR)/EquidistantSequence.Plo \
./$(DEPDIR)/FejerQuadrature.Plo ./$(DEPDIR)/FourierImage.Plo \
./$(DEPDIR)/Gauss1DQuadrature.Plo \
./$(DEPDIR)/GaussHermiteQuadrature.Plo \
./$(DEPDIR)/GaussLegendreQuadrature.Plo \
./$(DEPDIR)/GaussLegendreQuadrature2D.Plo \
./$(DEPDIR)/GaussLegendreQuadratureQ.Plo \
./$(DEPDIR)/GridAxis.Plo \
./$(DEPDIR)/HeatEq1DNeumannBoundary.Plo \
./$(DEPDIR)/LinInterpolatedTable1D.Plo \
./$(DEPDIR)/MathUtils.Plo ./$(DEPDIR)/OrthoPoly1D.Plo \
./$(DEPDIR)/OrthoPolyMethod.Plo ./$(DEPDIR)/Poly1D.Plo \
./$(DEPDIR)/RectangleQuadrature1D.Plo \
./$(DEPDIR)/RecurrenceCoeffs.Plo \
./$(DEPDIR)/ScalableClassicalOrthoPoly1D.Plo \
./$(DEPDIR)/ScanExtremum1D.Plo \
./$(DEPDIR)/SemiInfGaussianQuadrature.Plo \
./$(DEPDIR)/SpecialFunctions.Plo \
./$(DEPDIR)/StorablePolySeries1D.Plo ./$(DEPDIR)/SvdMethod.Plo \
./$(DEPDIR)/UniformAxis.Plo ./$(DEPDIR)/bilinearSection.Plo \
./$(DEPDIR)/binomialCoefficient.Plo \
./$(DEPDIR)/definiteIntegrals.Plo ./$(DEPDIR)/findPeak2D.Plo \
./$(DEPDIR)/goldenSectionSearch.Plo \
./$(DEPDIR)/lapack_interface.Plo \
./$(DEPDIR)/matrixIndexPairs.Plo \
./$(DEPDIR)/performSchultzIteration.Plo \
./$(DEPDIR)/rectangleQuadrature.Plo \
./$(DEPDIR)/sineTransformMatrix.Plo ./$(DEPDIR)/timestamp.Plo \
./$(DEPDIR)/truncatedInverseSqrt.Plo
am__mv = mv -f
CXXCOMPILE = $(CXX) $(DEFS) $(DEFAULT_INCLUDES) $(INCLUDES) \
$(AM_CPPFLAGS) $(CPPFLAGS) $(AM_CXXFLAGS) $(CXXFLAGS)
LTCXXCOMPILE = $(LIBTOOL) $(AM_V_lt) --tag=CXX $(AM_LIBTOOLFLAGS) \
$(LIBTOOLFLAGS) --mode=compile $(CXX) $(DEFS) \
$(DEFAULT_INCLUDES) $(INCLUDES) $(AM_CPPFLAGS) $(CPPFLAGS) \
$(AM_CXXFLAGS) $(CXXFLAGS)
AM_V_CXX = $(am__v_CXX_@AM_V@)
am__v_CXX_ = $(am__v_CXX_@AM_DEFAULT_V@)
am__v_CXX_0 = @echo " CXX " $@;
am__v_CXX_1 =
CXXLD = $(CXX)
CXXLINK = $(LIBTOOL) $(AM_V_lt) --tag=CXX $(AM_LIBTOOLFLAGS) \
$(LIBTOOLFLAGS) --mode=link $(CXXLD) $(AM_CXXFLAGS) \
$(CXXFLAGS) $(AM_LDFLAGS) $(LDFLAGS) -o $@
AM_V_CXXLD = $(am__v_CXXLD_@AM_V@)
am__v_CXXLD_ = $(am__v_CXXLD_@AM_DEFAULT_V@)
am__v_CXXLD_0 = @echo " CXXLD " $@;
am__v_CXXLD_1 =
SOURCES = $(libnm_la_SOURCES)
DIST_SOURCES = $(libnm_la_SOURCES)
am__can_run_installinfo = \
case $$AM_UPDATE_INFO_DIR in \
n|no|NO) false;; \
*) (install-info --version) >/dev/null 2>&1;; \
esac
am__vpath_adj_setup = srcdirstrip=`echo "$(srcdir)" | sed 's|.|.|g'`;
am__vpath_adj = case $$p in \
$(srcdir)/*) f=`echo "$$p" | sed "s|^$$srcdirstrip/||"`;; \
*) f=$$p;; \
esac;
am__strip_dir = f=`echo $$p | sed -e 's|^.*/||'`;
am__install_max = 40
am__nobase_strip_setup = \
srcdirstrip=`echo "$(srcdir)" | sed 's/[].[^$$\\*|]/\\\\&/g'`
am__nobase_strip = \
for p in $$list; do echo "$$p"; done | sed -e "s|$$srcdirstrip/||"
am__nobase_list = $(am__nobase_strip_setup); \
for p in $$list; do echo "$$p $$p"; done | \
sed "s| $$srcdirstrip/| |;"' / .*\//!s/ .*/ ./; s,\( .*\)/[^/]*$$,\1,' | \
$(AWK) 'BEGIN { files["."] = "" } { files[$$2] = files[$$2] " " $$1; \
if (++n[$$2] == $(am__install_max)) \
{ print $$2, files[$$2]; n[$$2] = 0; files[$$2] = "" } } \
END { for (dir in files) print dir, files[dir] }'
am__base_list = \
sed '$$!N;$$!N;$$!N;$$!N;$$!N;$$!N;$$!N;s/\n/ /g' | \
sed '$$!N;$$!N;$$!N;$$!N;s/\n/ /g'
am__uninstall_files_from_dir = { \
test -z "$$files" \
|| { test ! -d "$$dir" && test ! -f "$$dir" && test ! -r "$$dir"; } \
|| { echo " ( cd '$$dir' && rm -f" $$files ")"; \
$(am__cd) "$$dir" && rm -f $$files; }; \
}
am__installdirs = "$(DESTDIR)$(includedir)"
HEADERS = $(include_HEADERS)
am__extra_recursive_targets = python-recursive
am__tagged_files = $(HEADERS) $(SOURCES) $(TAGS_FILES) $(LISP)
# Read a list of newline-separated strings from the standard input,
# and print each of them once, without duplicates. Input order is
# *not* preserved.
am__uniquify_input = $(AWK) '\
BEGIN { nonempty = 0; } \
{ items[$$0] = 1; nonempty = 1; } \
END { if (nonempty) { for (i in items) print i; }; } \
'
# Make sure the list of sources is unique. This is necessary because,
# e.g., the same source file might be shared among _SOURCES variables
# for different programs/libraries.
am__define_uniq_tagged_files = \
list='$(am__tagged_files)'; \
unique=`for i in $$list; do \
if test -f "$$i"; then echo $$i; else echo $(srcdir)/$$i; fi; \
done | $(am__uniquify_input)`
am__DIST_COMMON = $(srcdir)/Makefile.in $(top_srcdir)/depcomp
DISTFILES = $(DIST_COMMON) $(DIST_SOURCES) $(TEXINFOS) $(EXTRA_DIST)
ACLOCAL = @ACLOCAL@
AMTAR = @AMTAR@
AM_DEFAULT_VERBOSITY = @AM_DEFAULT_VERBOSITY@
AR = @AR@
AUTOCONF = @AUTOCONF@
AUTOHEADER = @AUTOHEADER@
AUTOMAKE = @AUTOMAKE@
AWK = @AWK@
CC = @CC@
CCDEPMODE = @CCDEPMODE@
CFLAGS = @CFLAGS@
CPPFLAGS = @CPPFLAGS@
CSCOPE = @CSCOPE@
CTAGS = @CTAGS@
CXX = @CXX@
CXXCPP = @CXXCPP@
CXXDEPMODE = @CXXDEPMODE@
CXXFLAGS = @CXXFLAGS@
CYGPATH_W = @CYGPATH_W@
DEFS = @DEFS@
DEPDIR = @DEPDIR@
DEPS_CFLAGS = @DEPS_CFLAGS@
DEPS_LIBS = @DEPS_LIBS@
DLLTOOL = @DLLTOOL@
DSYMUTIL = @DSYMUTIL@
DUMPBIN = @DUMPBIN@
ECHO_C = @ECHO_C@
ECHO_N = @ECHO_N@
ECHO_T = @ECHO_T@
EGREP = @EGREP@
ETAGS = @ETAGS@
EXEEXT = @EXEEXT@
F77 = @F77@
FFLAGS = @FFLAGS@
FGREP = @FGREP@
FLIBS = @FLIBS@
GREP = @GREP@
INSTALL = @INSTALL@
INSTALL_DATA = @INSTALL_DATA@
INSTALL_PROGRAM = @INSTALL_PROGRAM@
INSTALL_SCRIPT = @INSTALL_SCRIPT@
INSTALL_STRIP_PROGRAM = @INSTALL_STRIP_PROGRAM@
LD = @LD@
LDFLAGS = @LDFLAGS@
LIBOBJS = @LIBOBJS@
LIBS = @LIBS@
LIBTOOL = @LIBTOOL@
LIPO = @LIPO@
LN_S = @LN_S@
LTLIBOBJS = @LTLIBOBJS@
LT_SYS_LIBRARY_PATH = @LT_SYS_LIBRARY_PATH@
MAKEINFO = @MAKEINFO@
MANIFEST_TOOL = @MANIFEST_TOOL@
MKDIR_P = @MKDIR_P@
NM = @NM@
NMEDIT = @NMEDIT@
OBJDUMP = @OBJDUMP@
OBJEXT = @OBJEXT@
OTOOL = @OTOOL@
OTOOL64 = @OTOOL64@
PACKAGE = @PACKAGE@
PACKAGE_BUGREPORT = @PACKAGE_BUGREPORT@
PACKAGE_NAME = @PACKAGE_NAME@
PACKAGE_STRING = @PACKAGE_STRING@
PACKAGE_TARNAME = @PACKAGE_TARNAME@
PACKAGE_URL = @PACKAGE_URL@
PACKAGE_VERSION = @PACKAGE_VERSION@
PATH_SEPARATOR = @PATH_SEPARATOR@
PKG_CONFIG = @PKG_CONFIG@
PKG_CONFIG_LIBDIR = @PKG_CONFIG_LIBDIR@
PKG_CONFIG_PATH = @PKG_CONFIG_PATH@
RANLIB = @RANLIB@
SED = @SED@
SET_MAKE = @SET_MAKE@
SHELL = @SHELL@
STRIP = @STRIP@
VERSION = @VERSION@
abs_builddir = @abs_builddir@
abs_srcdir = @abs_srcdir@
abs_top_builddir = @abs_top_builddir@
abs_top_srcdir = @abs_top_srcdir@
ac_ct_AR = @ac_ct_AR@
ac_ct_CC = @ac_ct_CC@
ac_ct_CXX = @ac_ct_CXX@
ac_ct_DUMPBIN = @ac_ct_DUMPBIN@
ac_ct_F77 = @ac_ct_F77@
am__include = @am__include@
am__leading_dot = @am__leading_dot@
am__quote = @am__quote@
am__tar = @am__tar@
am__untar = @am__untar@
bindir = @bindir@
build = @build@
build_alias = @build_alias@
build_cpu = @build_cpu@
build_os = @build_os@
build_vendor = @build_vendor@
builddir = @builddir@
datadir = @datadir@
datarootdir = @datarootdir@
docdir = @docdir@
dvidir = @dvidir@
exec_prefix = @exec_prefix@
host = @host@
host_alias = @host_alias@
host_cpu = @host_cpu@
host_os = @host_os@
host_vendor = @host_vendor@
htmldir = @htmldir@
includedir = ${prefix}/include/npstat/nm
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 = libnm.la
libnm_la_SOURCES = ArrayShape.cc ArrayRange.cc SpecialFunctions.cc \
ConvolutionEngine1D.cc EquidistantSequence.cc GaussHermiteQuadrature.cc \
GaussLegendreQuadrature.cc MathUtils.cc OrthoPoly1D.cc GridAxis.cc \
rectangleQuadrature.cc LinInterpolatedTable1D.cc ScanExtremum1D.cc \
bilinearSection.cc ConvolutionEngineND.cc FourierImage.cc SvdMethod.cc \
binomialCoefficient.cc UniformAxis.cc ArrayNDScanner.cc DualAxis.cc \
DiscreteBernsteinPoly1D.cc definiteIntegrals.cc EigenMethod.cc \
goldenSectionSearch.cc timestamp.cc OrthoPolyMethod.cc ContOrthoPoly1D.cc \
lapack_interface.cc AbsClassicalOrthoPoly1D.cc ClassicalOrthoPolys1D.cc \
matrixIndexPairs.cc truncatedInverseSqrt.cc FejerQuadrature.cc \
StorablePolySeries1D.cc SemiInfGaussianQuadrature.cc Gauss1DQuadrature.cc \
HeatEq1DNeumannBoundary.cc performSchultzIteration.cc RecurrenceCoeffs.cc \
GaussLegendreQuadratureQ.cc GaussLegendreQuadrature2D.cc Poly1D.cc \
ScalableClassicalOrthoPoly1D.cc RectangleQuadrature1D.cc findPeak2D.cc \
sineTransformMatrix.cc
include_HEADERS = AbsArrayProjector.hh \
AbsClassicalOrthoPoly1D.hh \
AbsClassicalOrthoPoly1D.icc \
absDifference.hh \
AbsIntervalQuadrature1D.hh \
AbsMultivariateFunctor.hh \
AbsVisitor.hh \
allocators.hh \
areAllElementsUnique.hh \
ArrayND.hh \
ArrayND.icc \
ArrayNDScanner.hh \
ArrayRange.hh \
ArrayShape.hh \
bilinearSection.hh \
BindKernel.hh \
binomialCoefficient.hh \
BoundaryInclusion.hh \
BoxND.hh \
BoxND.icc \
BoxNDScanner.hh \
BoxNDScanner.icc \
cdKernelSensitivityMatrix.hh \
cdKernelSensitivityMatrix.icc \
CircularMapper1d.hh \
ClassicalOrthoPoly1DFromWeight.hh \
ClassicalOrthoPoly1DFromWeight.icc \
ClassicalOrthoPolys1D.hh \
closeWithinTolerance.hh \
CompareByIndex.hh \
ComplexComparesAbs.hh \
ComplexComparesFalse.hh \
ConstSubscriptMap.hh \
ContOrthoPoly1D.hh \
ContOrthoPoly1D.icc \
ConvolutionDensity1D.hh \
ConvolutionDensity1D.icc \
ConvolutionEngine1D.hh \
ConvolutionEngine1D.icc \
ConvolutionEngineND.hh \
ConvolutionEngineND.icc \
coordAndWeight.hh \
CoordinateSelector.hh \
definiteIntegrals.hh \
DiscreteBernsteinPoly1D.hh \
discretizedDistance.hh \
discretizedDistance.icc \
DualAxis.hh \
EigenMethod.hh \
EquidistantSequence.hh \
ExpMapper1d.hh \
fcnOrConst.hh \
FejerQuadrature.hh \
FejerQuadrature.icc \
fillArrayCentersPreservingAreas.hh \
findPeak2D.hh \
findRootInLogSpace.hh \
findRootInLogSpace.icc \
findRootNewtonRaphson.hh \
findRootNewtonRaphson.icc \
findRootUsingBisections.hh \
findRootUsingBisections.icc \
float128IO.hh \
FourierImage.hh \
Gauss1DQuadrature.hh \
GaussHermiteQuadrature.hh \
GaussHermiteQuadrature.icc \
GaussianDip.hh \
GaussLegendreQuadrature.hh \
GaussLegendreQuadrature.icc \
GaussLegendreQuadrature2D.hh \
GaussLegendreQuadrature2D.icc \
GaussLegendreQuadratureQ.hh \
GaussLegendreQuadratureQ.icc \
GeneralizedComplex.hh \
goldenSectionSearch.hh \
goldenSectionSearch.icc \
GridAxis.hh \
HeatEq1DNeumannBoundary.hh \
interpolate.hh \
interpolate.icc \
Interval.hh \
Interval.icc \
isMonotonous.hh \
KDTree.hh \
KDTree.icc \
kernelSensitivityMatrix.hh \
kernelSensitivityMatrix.icc \
lapack.h \
lapack_double.h \
lapack_interface.hh \
lapack_interface.icc \
lapack_interface_double.icc \
lapack_interface_ldouble.icc \
lapack_interface_float.icc \
LinearMapper1d.hh \
LinInterpolatedTable1D.hh \
LinInterpolatedTable1D.icc \
LinInterpolatedTableND.hh \
LinInterpolatedTableND.icc \
LogMapper1d.hh \
LongerType.hh \
MathUtils.hh \
MathUtils.icc \
Matrix.hh \
matrixIndexPairs.hh \
Matrix.icc \
MinSearchStatus1D.hh \
MultivariateFunctorScanner.hh \
OrthoPoly1D.hh \
OrthoPoly1D.icc \
OrthoPolyMethod.hh \
OrthoPolyND.hh \
OrthoPolyND.icc \
PairCompare.hh \
performSchultzIteration.hh \
PointDimensionality.hh \
Poly1D.hh \
polyPrivateUtils.hh \
polyPrivateUtils.icc \
PreciseType.hh \
ProperDblFromCmpl.hh \
PtrBufferHandle.hh \
RectangleQuadrature1D.hh \
RectangleQuadrature1D.icc \
Recurrence.hh \
RecurrenceCoeffs.hh \
RecurrenceCoeffs.icc \
RecurrenceCoeffsTrGauss.hh \
RecurrenceCoeffsTrGauss.icc \
rectangleQuadrature.hh \
rescanArray.hh \
rescanArray.icc \
ScanExtremum1D.hh \
ScalableClassicalOrthoPoly1D.hh \
ScalableClassicalOrthoPoly1D.icc \
SemiInfGaussianQuadrature.hh \
SemiInfGaussianQuadrature.icc \
SimpleFunctors.hh \
sineTransformMatrix.hh \
SpecialFunctions.hh \
std_quadmath.hh \
StorablePolySeries1D.hh \
StorablePolySeries1D.icc \
sumOfSquares.hh \
SvdMethod.hh \
timestamp.hh \
Triple.hh \
truncatedInverseSqrt.hh \
- UniformAxis.hh
+ UniformAxis.hh \
+ vectorAsText.hh
EXTRA_DIST = 00README.txt
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/nm/Makefile'; \
$(am__cd) $(top_srcdir) && \
$(AUTOMAKE) --foreign npstat/nm/Makefile
Makefile: $(srcdir)/Makefile.in $(top_builddir)/config.status
@case '$?' in \
*config.status*) \
cd $(top_builddir) && $(MAKE) $(AM_MAKEFLAGS) am--refresh;; \
*) \
echo ' cd $(top_builddir) && $(SHELL) ./config.status $(subdir)/$@ $(am__maybe_remake_depfiles)'; \
cd $(top_builddir) && $(SHELL) ./config.status $(subdir)/$@ $(am__maybe_remake_depfiles);; \
esac;
$(top_builddir)/config.status: $(top_srcdir)/configure $(CONFIG_STATUS_DEPENDENCIES)
cd $(top_builddir) && $(MAKE) $(AM_MAKEFLAGS) am--refresh
$(top_srcdir)/configure: $(am__configure_deps)
cd $(top_builddir) && $(MAKE) $(AM_MAKEFLAGS) am--refresh
$(ACLOCAL_M4): $(am__aclocal_m4_deps)
cd $(top_builddir) && $(MAKE) $(AM_MAKEFLAGS) am--refresh
$(am__aclocal_m4_deps):
clean-noinstLTLIBRARIES:
-test -z "$(noinst_LTLIBRARIES)" || rm -f $(noinst_LTLIBRARIES)
@list='$(noinst_LTLIBRARIES)'; \
locs=`for p in $$list; do echo $$p; done | \
sed 's|^[^/]*$$|.|; s|/[^/]*$$||; s|$$|/so_locations|' | \
sort -u`; \
test -z "$$locs" || { \
echo rm -f $${locs}; \
rm -f $${locs}; \
}
libnm.la: $(libnm_la_OBJECTS) $(libnm_la_DEPENDENCIES) $(EXTRA_libnm_la_DEPENDENCIES)
$(AM_V_CXXLD)$(CXXLINK) $(libnm_la_OBJECTS) $(libnm_la_LIBADD) $(LIBS)
mostlyclean-compile:
-rm -f *.$(OBJEXT)
distclean-compile:
-rm -f *.tab.c
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/AbsClassicalOrthoPoly1D.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/ArrayNDScanner.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/ArrayRange.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/ArrayShape.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/ClassicalOrthoPolys1D.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/ContOrthoPoly1D.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/ConvolutionEngine1D.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/ConvolutionEngineND.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/DiscreteBernsteinPoly1D.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/DualAxis.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/EigenMethod.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/EquidistantSequence.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/FejerQuadrature.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/FourierImage.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/Gauss1DQuadrature.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/GaussHermiteQuadrature.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/GaussLegendreQuadrature.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/GaussLegendreQuadrature2D.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/GaussLegendreQuadratureQ.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/GridAxis.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/HeatEq1DNeumannBoundary.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/LinInterpolatedTable1D.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/MathUtils.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/OrthoPoly1D.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/OrthoPolyMethod.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/Poly1D.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/RectangleQuadrature1D.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/RecurrenceCoeffs.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/ScalableClassicalOrthoPoly1D.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/ScanExtremum1D.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/SemiInfGaussianQuadrature.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/SpecialFunctions.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/StorablePolySeries1D.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/SvdMethod.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/UniformAxis.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/bilinearSection.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/binomialCoefficient.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/definiteIntegrals.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/findPeak2D.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/goldenSectionSearch.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/lapack_interface.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/matrixIndexPairs.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/performSchultzIteration.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/rectangleQuadrature.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/sineTransformMatrix.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/timestamp.Plo@am__quote@ # am--include-marker
@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/truncatedInverseSqrt.Plo@am__quote@ # am--include-marker
$(am__depfiles_remade):
@$(MKDIR_P) $(@D)
@echo '# dummy' >$@-t && $(am__mv) $@-t $@
am--depfiles: $(am__depfiles_remade)
.cc.o:
@am__fastdepCXX_TRUE@ $(AM_V_CXX)$(CXXCOMPILE) -MT $@ -MD -MP -MF $(DEPDIR)/$*.Tpo -c -o $@ $<
@am__fastdepCXX_TRUE@ $(AM_V_at)$(am__mv) $(DEPDIR)/$*.Tpo $(DEPDIR)/$*.Po
@AMDEP_TRUE@@am__fastdepCXX_FALSE@ $(AM_V_CXX)source='$<' object='$@' libtool=no @AMDEPBACKSLASH@
@AMDEP_TRUE@@am__fastdepCXX_FALSE@ DEPDIR=$(DEPDIR) $(CXXDEPMODE) $(depcomp) @AMDEPBACKSLASH@
@am__fastdepCXX_FALSE@ $(AM_V_CXX@am__nodep@)$(CXXCOMPILE) -c -o $@ $<
.cc.obj:
@am__fastdepCXX_TRUE@ $(AM_V_CXX)$(CXXCOMPILE) -MT $@ -MD -MP -MF $(DEPDIR)/$*.Tpo -c -o $@ `$(CYGPATH_W) '$<'`
@am__fastdepCXX_TRUE@ $(AM_V_at)$(am__mv) $(DEPDIR)/$*.Tpo $(DEPDIR)/$*.Po
@AMDEP_TRUE@@am__fastdepCXX_FALSE@ $(AM_V_CXX)source='$<' object='$@' libtool=no @AMDEPBACKSLASH@
@AMDEP_TRUE@@am__fastdepCXX_FALSE@ DEPDIR=$(DEPDIR) $(CXXDEPMODE) $(depcomp) @AMDEPBACKSLASH@
@am__fastdepCXX_FALSE@ $(AM_V_CXX@am__nodep@)$(CXXCOMPILE) -c -o $@ `$(CYGPATH_W) '$<'`
.cc.lo:
@am__fastdepCXX_TRUE@ $(AM_V_CXX)$(LTCXXCOMPILE) -MT $@ -MD -MP -MF $(DEPDIR)/$*.Tpo -c -o $@ $<
@am__fastdepCXX_TRUE@ $(AM_V_at)$(am__mv) $(DEPDIR)/$*.Tpo $(DEPDIR)/$*.Plo
@AMDEP_TRUE@@am__fastdepCXX_FALSE@ $(AM_V_CXX)source='$<' object='$@' libtool=yes @AMDEPBACKSLASH@
@AMDEP_TRUE@@am__fastdepCXX_FALSE@ DEPDIR=$(DEPDIR) $(CXXDEPMODE) $(depcomp) @AMDEPBACKSLASH@
@am__fastdepCXX_FALSE@ $(AM_V_CXX@am__nodep@)$(LTCXXCOMPILE) -c -o $@ $<
mostlyclean-libtool:
-rm -f *.lo
clean-libtool:
-rm -rf .libs _libs
install-includeHEADERS: $(include_HEADERS)
@$(NORMAL_INSTALL)
@list='$(include_HEADERS)'; test -n "$(includedir)" || list=; \
if test -n "$$list"; then \
echo " $(MKDIR_P) '$(DESTDIR)$(includedir)'"; \
$(MKDIR_P) "$(DESTDIR)$(includedir)" || exit 1; \
fi; \
for p in $$list; do \
if test -f "$$p"; then d=; else d="$(srcdir)/"; fi; \
echo "$$d$$p"; \
done | $(am__base_list) | \
while read files; do \
echo " $(INSTALL_HEADER) $$files '$(DESTDIR)$(includedir)'"; \
$(INSTALL_HEADER) $$files "$(DESTDIR)$(includedir)" || exit $$?; \
done
uninstall-includeHEADERS:
@$(NORMAL_UNINSTALL)
@list='$(include_HEADERS)'; test -n "$(includedir)" || list=; \
files=`for p in $$list; do echo $$p; done | sed -e 's|^.*/||'`; \
dir='$(DESTDIR)$(includedir)'; $(am__uninstall_files_from_dir)
python-local:
ID: $(am__tagged_files)
$(am__define_uniq_tagged_files); mkid -fID $$unique
tags: tags-am
TAGS: tags
tags-am: $(TAGS_DEPENDENCIES) $(am__tagged_files)
set x; \
here=`pwd`; \
$(am__define_uniq_tagged_files); \
shift; \
if test -z "$(ETAGS_ARGS)$$*$$unique"; then :; else \
test -n "$$unique" || unique=$$empty_fix; \
if test $$# -gt 0; then \
$(ETAGS) $(ETAGSFLAGS) $(AM_ETAGSFLAGS) $(ETAGS_ARGS) \
"$$@" $$unique; \
else \
$(ETAGS) $(ETAGSFLAGS) $(AM_ETAGSFLAGS) $(ETAGS_ARGS) \
$$unique; \
fi; \
fi
ctags: ctags-am
CTAGS: ctags
ctags-am: $(TAGS_DEPENDENCIES) $(am__tagged_files)
$(am__define_uniq_tagged_files); \
test -z "$(CTAGS_ARGS)$$unique" \
|| $(CTAGS) $(CTAGSFLAGS) $(AM_CTAGSFLAGS) $(CTAGS_ARGS) \
$$unique
GTAGS:
here=`$(am__cd) $(top_builddir) && pwd` \
&& $(am__cd) $(top_srcdir) \
&& gtags -i $(GTAGS_ARGS) "$$here"
cscopelist: cscopelist-am
cscopelist-am: $(am__tagged_files)
list='$(am__tagged_files)'; \
case "$(srcdir)" in \
[\\/]* | ?:[\\/]*) sdir="$(srcdir)" ;; \
*) sdir=$(subdir)/$(srcdir) ;; \
esac; \
for i in $$list; do \
if test -f "$$i"; then \
echo "$(subdir)/$$i"; \
else \
echo "$$sdir/$$i"; \
fi; \
done >> $(top_builddir)/cscope.files
distclean-tags:
-rm -f TAGS ID GTAGS GRTAGS GSYMS GPATH tags
distdir: $(BUILT_SOURCES)
$(MAKE) $(AM_MAKEFLAGS) distdir-am
distdir-am: $(DISTFILES)
@srcdirstrip=`echo "$(srcdir)" | sed 's/[].[^$$\\*]/\\\\&/g'`; \
topsrcdirstrip=`echo "$(top_srcdir)" | sed 's/[].[^$$\\*]/\\\\&/g'`; \
list='$(DISTFILES)'; \
dist_files=`for file in $$list; do echo $$file; done | \
sed -e "s|^$$srcdirstrip/||;t" \
-e "s|^$$topsrcdirstrip/|$(top_builddir)/|;t"`; \
case $$dist_files in \
*/*) $(MKDIR_P) `echo "$$dist_files" | \
sed '/\//!d;s|^|$(distdir)/|;s,/[^/]*$$,,' | \
sort -u` ;; \
esac; \
for file in $$dist_files; do \
if test -f $$file || test -d $$file; then d=.; else d=$(srcdir); fi; \
if test -d $$d/$$file; then \
dir=`echo "/$$file" | sed -e 's,/[^/]*$$,,'`; \
if test -d "$(distdir)/$$file"; then \
find "$(distdir)/$$file" -type d ! -perm -700 -exec chmod u+rwx {} \;; \
fi; \
if test -d $(srcdir)/$$file && test $$d != $(srcdir); then \
cp -fpR $(srcdir)/$$file "$(distdir)$$dir" || exit 1; \
find "$(distdir)/$$file" -type d ! -perm -700 -exec chmod u+rwx {} \;; \
fi; \
cp -fpR $$d/$$file "$(distdir)$$dir" || exit 1; \
else \
test -f "$(distdir)/$$file" \
|| cp -p $$d/$$file "$(distdir)/$$file" \
|| exit 1; \
fi; \
done
check-am: all-am
check: check-am
all-am: Makefile $(LTLIBRARIES) $(HEADERS)
installdirs:
for dir in "$(DESTDIR)$(includedir)"; do \
test -z "$$dir" || $(MKDIR_P) "$$dir"; \
done
install: install-am
install-exec: install-exec-am
install-data: install-data-am
uninstall: uninstall-am
install-am: all-am
@$(MAKE) $(AM_MAKEFLAGS) install-exec-am install-data-am
installcheck: installcheck-am
install-strip:
if test -z '$(STRIP)'; then \
$(MAKE) $(AM_MAKEFLAGS) INSTALL_PROGRAM="$(INSTALL_STRIP_PROGRAM)" \
install_sh_PROGRAM="$(INSTALL_STRIP_PROGRAM)" INSTALL_STRIP_FLAG=-s \
install; \
else \
$(MAKE) $(AM_MAKEFLAGS) INSTALL_PROGRAM="$(INSTALL_STRIP_PROGRAM)" \
install_sh_PROGRAM="$(INSTALL_STRIP_PROGRAM)" INSTALL_STRIP_FLAG=-s \
"INSTALL_PROGRAM_ENV=STRIPPROG='$(STRIP)'" install; \
fi
mostlyclean-generic:
clean-generic:
distclean-generic:
-test -z "$(CONFIG_CLEAN_FILES)" || rm -f $(CONFIG_CLEAN_FILES)
-test . = "$(srcdir)" || test -z "$(CONFIG_CLEAN_VPATH_FILES)" || rm -f $(CONFIG_CLEAN_VPATH_FILES)
maintainer-clean-generic:
@echo "This command is intended for maintainers to use"
@echo "it deletes files that may require special tools to rebuild."
clean: clean-am
clean-am: clean-generic clean-libtool clean-noinstLTLIBRARIES \
mostlyclean-am
distclean: distclean-am
-rm -f ./$(DEPDIR)/AbsClassicalOrthoPoly1D.Plo
-rm -f ./$(DEPDIR)/ArrayNDScanner.Plo
-rm -f ./$(DEPDIR)/ArrayRange.Plo
-rm -f ./$(DEPDIR)/ArrayShape.Plo
-rm -f ./$(DEPDIR)/ClassicalOrthoPolys1D.Plo
-rm -f ./$(DEPDIR)/ContOrthoPoly1D.Plo
-rm -f ./$(DEPDIR)/ConvolutionEngine1D.Plo
-rm -f ./$(DEPDIR)/ConvolutionEngineND.Plo
-rm -f ./$(DEPDIR)/DiscreteBernsteinPoly1D.Plo
-rm -f ./$(DEPDIR)/DualAxis.Plo
-rm -f ./$(DEPDIR)/EigenMethod.Plo
-rm -f ./$(DEPDIR)/EquidistantSequence.Plo
-rm -f ./$(DEPDIR)/FejerQuadrature.Plo
-rm -f ./$(DEPDIR)/FourierImage.Plo
-rm -f ./$(DEPDIR)/Gauss1DQuadrature.Plo
-rm -f ./$(DEPDIR)/GaussHermiteQuadrature.Plo
-rm -f ./$(DEPDIR)/GaussLegendreQuadrature.Plo
-rm -f ./$(DEPDIR)/GaussLegendreQuadrature2D.Plo
-rm -f ./$(DEPDIR)/GaussLegendreQuadratureQ.Plo
-rm -f ./$(DEPDIR)/GridAxis.Plo
-rm -f ./$(DEPDIR)/HeatEq1DNeumannBoundary.Plo
-rm -f ./$(DEPDIR)/LinInterpolatedTable1D.Plo
-rm -f ./$(DEPDIR)/MathUtils.Plo
-rm -f ./$(DEPDIR)/OrthoPoly1D.Plo
-rm -f ./$(DEPDIR)/OrthoPolyMethod.Plo
-rm -f ./$(DEPDIR)/Poly1D.Plo
-rm -f ./$(DEPDIR)/RectangleQuadrature1D.Plo
-rm -f ./$(DEPDIR)/RecurrenceCoeffs.Plo
-rm -f ./$(DEPDIR)/ScalableClassicalOrthoPoly1D.Plo
-rm -f ./$(DEPDIR)/ScanExtremum1D.Plo
-rm -f ./$(DEPDIR)/SemiInfGaussianQuadrature.Plo
-rm -f ./$(DEPDIR)/SpecialFunctions.Plo
-rm -f ./$(DEPDIR)/StorablePolySeries1D.Plo
-rm -f ./$(DEPDIR)/SvdMethod.Plo
-rm -f ./$(DEPDIR)/UniformAxis.Plo
-rm -f ./$(DEPDIR)/bilinearSection.Plo
-rm -f ./$(DEPDIR)/binomialCoefficient.Plo
-rm -f ./$(DEPDIR)/definiteIntegrals.Plo
-rm -f ./$(DEPDIR)/findPeak2D.Plo
-rm -f ./$(DEPDIR)/goldenSectionSearch.Plo
-rm -f ./$(DEPDIR)/lapack_interface.Plo
-rm -f ./$(DEPDIR)/matrixIndexPairs.Plo
-rm -f ./$(DEPDIR)/performSchultzIteration.Plo
-rm -f ./$(DEPDIR)/rectangleQuadrature.Plo
-rm -f ./$(DEPDIR)/sineTransformMatrix.Plo
-rm -f ./$(DEPDIR)/timestamp.Plo
-rm -f ./$(DEPDIR)/truncatedInverseSqrt.Plo
-rm -f Makefile
distclean-am: clean-am distclean-compile distclean-generic \
distclean-tags
dvi: dvi-am
dvi-am:
html: html-am
html-am:
info: info-am
info-am:
install-data-am: install-includeHEADERS
install-dvi: install-dvi-am
install-dvi-am:
install-exec-am:
install-html: install-html-am
install-html-am:
install-info: install-info-am
install-info-am:
install-man:
install-pdf: install-pdf-am
install-pdf-am:
install-ps: install-ps-am
install-ps-am:
installcheck-am:
maintainer-clean: maintainer-clean-am
-rm -f ./$(DEPDIR)/AbsClassicalOrthoPoly1D.Plo
-rm -f ./$(DEPDIR)/ArrayNDScanner.Plo
-rm -f ./$(DEPDIR)/ArrayRange.Plo
-rm -f ./$(DEPDIR)/ArrayShape.Plo
-rm -f ./$(DEPDIR)/ClassicalOrthoPolys1D.Plo
-rm -f ./$(DEPDIR)/ContOrthoPoly1D.Plo
-rm -f ./$(DEPDIR)/ConvolutionEngine1D.Plo
-rm -f ./$(DEPDIR)/ConvolutionEngineND.Plo
-rm -f ./$(DEPDIR)/DiscreteBernsteinPoly1D.Plo
-rm -f ./$(DEPDIR)/DualAxis.Plo
-rm -f ./$(DEPDIR)/EigenMethod.Plo
-rm -f ./$(DEPDIR)/EquidistantSequence.Plo
-rm -f ./$(DEPDIR)/FejerQuadrature.Plo
-rm -f ./$(DEPDIR)/FourierImage.Plo
-rm -f ./$(DEPDIR)/Gauss1DQuadrature.Plo
-rm -f ./$(DEPDIR)/GaussHermiteQuadrature.Plo
-rm -f ./$(DEPDIR)/GaussLegendreQuadrature.Plo
-rm -f ./$(DEPDIR)/GaussLegendreQuadrature2D.Plo
-rm -f ./$(DEPDIR)/GaussLegendreQuadratureQ.Plo
-rm -f ./$(DEPDIR)/GridAxis.Plo
-rm -f ./$(DEPDIR)/HeatEq1DNeumannBoundary.Plo
-rm -f ./$(DEPDIR)/LinInterpolatedTable1D.Plo
-rm -f ./$(DEPDIR)/MathUtils.Plo
-rm -f ./$(DEPDIR)/OrthoPoly1D.Plo
-rm -f ./$(DEPDIR)/OrthoPolyMethod.Plo
-rm -f ./$(DEPDIR)/Poly1D.Plo
-rm -f ./$(DEPDIR)/RectangleQuadrature1D.Plo
-rm -f ./$(DEPDIR)/RecurrenceCoeffs.Plo
-rm -f ./$(DEPDIR)/ScalableClassicalOrthoPoly1D.Plo
-rm -f ./$(DEPDIR)/ScanExtremum1D.Plo
-rm -f ./$(DEPDIR)/SemiInfGaussianQuadrature.Plo
-rm -f ./$(DEPDIR)/SpecialFunctions.Plo
-rm -f ./$(DEPDIR)/StorablePolySeries1D.Plo
-rm -f ./$(DEPDIR)/SvdMethod.Plo
-rm -f ./$(DEPDIR)/UniformAxis.Plo
-rm -f ./$(DEPDIR)/bilinearSection.Plo
-rm -f ./$(DEPDIR)/binomialCoefficient.Plo
-rm -f ./$(DEPDIR)/definiteIntegrals.Plo
-rm -f ./$(DEPDIR)/findPeak2D.Plo
-rm -f ./$(DEPDIR)/goldenSectionSearch.Plo
-rm -f ./$(DEPDIR)/lapack_interface.Plo
-rm -f ./$(DEPDIR)/matrixIndexPairs.Plo
-rm -f ./$(DEPDIR)/performSchultzIteration.Plo
-rm -f ./$(DEPDIR)/rectangleQuadrature.Plo
-rm -f ./$(DEPDIR)/sineTransformMatrix.Plo
-rm -f ./$(DEPDIR)/timestamp.Plo
-rm -f ./$(DEPDIR)/truncatedInverseSqrt.Plo
-rm -f Makefile
maintainer-clean-am: distclean-am maintainer-clean-generic
mostlyclean: mostlyclean-am
mostlyclean-am: mostlyclean-compile mostlyclean-generic \
mostlyclean-libtool
pdf: pdf-am
pdf-am:
ps: ps-am
ps-am:
python: python-am
python-am: python-local
uninstall-am: uninstall-includeHEADERS
.MAKE: install-am install-strip
.PHONY: CTAGS GTAGS TAGS all all-am am--depfiles check check-am clean \
clean-generic clean-libtool clean-noinstLTLIBRARIES \
cscopelist-am ctags ctags-am distclean distclean-compile \
distclean-generic distclean-libtool distclean-tags distdir dvi \
dvi-am html html-am info info-am install install-am \
install-data install-data-am install-dvi install-dvi-am \
install-exec install-exec-am install-html install-html-am \
install-includeHEADERS install-info install-info-am \
install-man install-pdf install-pdf-am install-ps \
install-ps-am install-strip installcheck installcheck-am \
installdirs maintainer-clean maintainer-clean-generic \
mostlyclean mostlyclean-compile mostlyclean-generic \
mostlyclean-libtool pdf pdf-am ps ps-am python-am python-local \
tags tags-am uninstall uninstall-am uninstall-includeHEADERS
.PRECIOUS: Makefile
# Tell versions [3.59,3.63) of GNU make to not export all variables.
# Otherwise a system limit (for SysV at least) may be exceeded.
.NOEXPORT:
Index: trunk/npstat/stat/AbsNtuple.icc
===================================================================
--- trunk/npstat/stat/AbsNtuple.icc (revision 876)
+++ trunk/npstat/stat/AbsNtuple.icc (revision 877)
@@ -1,686 +1,686 @@
#include <cctype>
#include <cassert>
#include <sstream>
#include "geners/IOIsSameType.hh"
namespace npstat {
template <typename T>
inline AbsNtuple<T>::column_iterator::column_iterator()
: nt_(0), column_(0), row_(0)
{
}
template <typename T>
inline T AbsNtuple<T>::column_iterator::operator*() const
{
return (*nt_)(row_, column_);
}
template <typename T>
inline typename AbsNtuple<T>::column_iterator&
AbsNtuple<T>::column_iterator::operator++()
{
++row_;
return *this;
}
template <typename T>
inline typename AbsNtuple<T>::column_iterator
AbsNtuple<T>::column_iterator::operator++(int)
{
column_iterator tmp(*this);
++row_;
return tmp;
}
template <typename T>
inline bool AbsNtuple<T>::column_iterator::operator==(
const column_iterator& r) const
{
return row_ == r.row_;
}
template <typename T>
inline bool AbsNtuple<T>::column_iterator::operator!=(
const column_iterator& r) const
{
return row_ != r.row_;
}
template <typename T>
inline bool AbsNtuple<T>::column_iterator::operator<(
const column_iterator& r) const
{
return row_ < r.row_;
}
template <typename T>
inline AbsNtuple<T>::row_iterator::row_iterator()
: nt_(0), column_(0), row_(0)
{
}
template <typename T>
inline T AbsNtuple<T>::row_iterator::operator*() const
{
return (*nt_)(row_, column_);
}
template <typename T>
inline typename AbsNtuple<T>::row_iterator&
AbsNtuple<T>::row_iterator::operator++()
{
++column_;
return *this;
}
template <typename T>
inline typename AbsNtuple<T>::row_iterator
AbsNtuple<T>::row_iterator::operator++(int)
{
row_iterator tmp(*this);
++column_;
return tmp;
}
template <typename T>
inline bool AbsNtuple<T>::row_iterator::operator==(
const row_iterator& r) const
{
return column_ == r.column_;
}
template <typename T>
inline bool AbsNtuple<T>::row_iterator::operator!=(
const row_iterator& r) const
{
return column_ != r.column_;
}
template <typename T>
inline bool AbsNtuple<T>::row_iterator::operator<(
const row_iterator& r) const
{
return column_ < r.column_;
}
template <typename T>
inline typename AbsNtuple<T>::column_iterator
AbsNtuple<T>::column_begin(const Column& icolumn) const
{
column_iterator it;
it.nt_ = this;
it.column_ = icolumn(*this);
return it;
}
template <typename T>
inline typename AbsNtuple<T>::column_iterator
AbsNtuple<T>::column_end() const
{
column_iterator it;
it.row_ = nRows();
return it;
}
template <typename T>
inline typename AbsNtuple<T>::row_iterator
AbsNtuple<T>::row_begin(const unsigned long rowNumber) const
{
if (rowNumber >= nRows())
throw std::out_of_range("In npstat::AbsNtuple::row_begin: "
"row number is out of range");
row_iterator it;
it.nt_ = this;
it.row_ = rowNumber;
return it;
}
template <typename T>
inline typename AbsNtuple<T>::row_iterator
AbsNtuple<T>::row_end() const
{
row_iterator it;
it.column_ = colNames_.size();
return it;
}
template <typename T>
inline T AbsNtuple<T>::element(
const unsigned long r, const Column& c) const
{
return operator()(r, c(*this));
}
template <typename T>
inline T AbsNtuple<T>::elementAt(
const unsigned long r, const Column& c) const
{
return at(r, c(*this));
}
template <typename T>
bool AbsNtuple<T>::isEqual(const AbsNtuple& r) const
{
if (colNames_ != r.colNames_)
return false;
if (title_ != r.title_)
return false;
const unsigned long ncols = colNames_.size();
const unsigned long nrows = this->nRows();
if (nrows != r.nRows())
return false;
for (unsigned long irow=0; irow<nrows; ++irow)
for (unsigned long icol=0; icol<ncols; ++icol)
if ((*this)(irow, icol) != r(irow, icol))
return false;
return true;
}
template <typename T>
template <typename T2>
inline void AbsNtuple<T>::append(const AbsNtuple<T2>& another)
{
if (another.nColumns() != this->nColumns())
throw std::invalid_argument(
"In npstat::AbsNtuple::append: incompatible number of columns");
AppendNTuple<gs::IOIsSameType<T,T2>::value,T2>::append(this, another);
}
template <typename T>
template <class Accumulator>
void AbsNtuple<T>::cycleOverRows(Accumulator& acc) const
{
const unsigned long nr = this->nRows();
if (nr)
{
const unsigned long nc = colNames_.size();
std::vector<T> rowBuffer(nc);
T* buf = &rowBuffer[0];
for (unsigned long i=0UL; i < nr; ++i)
{
this->rowContents(i, buf, nc);
acc.accumulate(buf, nc);
}
}
}
template <typename T>
template <class Filter, class Accumulator>
unsigned long AbsNtuple<T>::conditionalCycleOverRows(
const Filter& filter, Accumulator& acc) const
{
unsigned long nPass = 0UL;
const unsigned long nr = this->nRows();
if (nr)
{
const unsigned long nc = colNames_.size();
std::vector<T> rowBuffer(nc);
T* buf = &rowBuffer[0];
const T* constbuf = buf;
for (unsigned long i=0UL; i < nr; ++i)
{
this->rowContents(i, buf, nc);
if (filter(i, constbuf, nc))
{
acc.accumulate(buf, nc);
++nPass;
}
}
}
return nPass;
}
template <typename T>
template <class Filter>
unsigned long AbsNtuple<T>::conditionalRowCount(
const Filter& filter) const
{
unsigned long nPass = 0UL;
const unsigned long nr = this->nRows();
if (nr)
{
const unsigned long nc = colNames_.size();
std::vector<T> rowBuffer(nc);
T* buf = &rowBuffer[0];
const T* constbuf = buf;
for (unsigned long i=0UL; i < nr; ++i)
{
this->rowContents(i, buf, nc);
if (filter(i, constbuf, nc))
++nPass;
}
}
return nPass;
}
template <typename T>
template <class Accumulator, class WeightCalc>
void AbsNtuple<T>::weightedCycleOverRows(
Accumulator& acc, const WeightCalc& wcalc, const bool skip0) const
{
const unsigned long nr = this->nRows();
if (nr)
{
const unsigned long nc = colNames_.size();
std::vector<T> rowBuffer(nc);
T* buf = &rowBuffer[0];
const T* constbuf = buf;
for (unsigned long i=0UL; i < nr; ++i)
{
this->rowContents(i, buf, nc);
const double w = wcalc(i, constbuf, nc);
if (w < 0.0)
throw std::invalid_argument(
"In npstat::AbsNtuple::weightedCycleOverRows: "
"negative weight");
if (w > 0.0 || !skip0)
acc.accumulate(buf, nc, w);
}
}
}
template <typename T>
template <class Filter, class Accumulator, class WeightCalc>
double AbsNtuple<T>::weightedConditionalCycleOverRows(
const Filter& filter, Accumulator& acc,
const WeightCalc& wcalc, const bool skip0) const
{
long double nPass = 0.0L;
const unsigned long nr = this->nRows();
if (nr)
{
const unsigned long nc = colNames_.size();
std::vector<T> rowBuffer(nc);
T* buf = &rowBuffer[0];
const T* constbuf = buf;
for (unsigned long i=0UL; i < nr; ++i)
{
this->rowContents(i, buf, nc);
if (filter(i, constbuf, nc))
{
const double w = wcalc(i, constbuf, nc);
if (w < 0.0)
throw std::invalid_argument(
"In npstat::AbsNtuple::weightedConditionalCycleOverRows:"
" negative weight");
if (w > 0.0 || !skip0)
acc.accumulate(buf, nc, w);
nPass += w;
}
}
}
return nPass;
}
template <typename T>
template <class Filter, class WeightCalc>
double AbsNtuple<T>::weightedConditionalRowCount(
const Filter& filter, const WeightCalc& wcalc) const
{
long double nPass = 0.0L;
const unsigned long nr = this->nRows();
if (nr)
{
const unsigned long nc = colNames_.size();
std::vector<T> rowBuffer(nc);
T* buf = &rowBuffer[0];
const T* constbuf = buf;
for (unsigned long i=0UL; i < nr; ++i)
{
this->rowContents(i, buf, nc);
if (filter(i, constbuf, nc))
{
const double w = wcalc(i, constbuf, nc);
if (w < 0.0)
throw std::invalid_argument(
"In npstat::AbsNtuple::weightedConditionalRowCount:"
" negative weight");
nPass += w;
}
}
}
return nPass;
}
template <typename T>
unsigned long AbsNtuple<T>::columnNumber(const char* columnName) const
{
assert(columnName);
const std::string* names = &colNames_[0];
const unsigned long ncols = colNames_.size();
unsigned long col = 0;
for (; col < ncols; ++col)
if (names[col] == columnName)
break;
return col;
}
template <typename T>
unsigned long AbsNtuple<T>::validColumn(
const char* columnName) const
{
assert(columnName);
const std::string* names = &colNames_[0];
const unsigned long ncols = colNames_.size();
for (unsigned long col = 0; col < ncols; ++col)
if (names[col] == columnName)
return col;
{
std::string err = "In npstat::AbsNtuple::validColumn: "
"no column named \"";
err += columnName;
err += "\"";
throw std::invalid_argument(err);
}
return 0;
}
template <typename T>
bool AbsNtuple<T>::setColumnName(const unsigned long i,
const char* newname)
{
const unsigned long n = colNames_.size();
if (i >= n)
return false;
if (columnNumber(newname) < n)
return false;
colNames_[i] = newname;
return true;
}
template <typename T>
std::vector<unsigned long> AbsNtuple<T>::columnIndices(const Column& c0) const
{
std::vector<unsigned long> idx(1);
idx[0] = c0(*this);
return idx;
}
template <typename T>
std::vector<unsigned long> AbsNtuple<T>::columnIndices(const Column& c0,
const Column& c1) const
{
std::vector<unsigned long> idx(2);
idx[0] = c0(*this);
idx[1] = c1(*this);
return idx;
}
template <typename T>
std::vector<unsigned long> AbsNtuple<T>::columnIndices(const Column& c0,
const Column& c1,
const Column& c2) const
{
std::vector<unsigned long> idx(3);
idx[0] = c0(*this);
idx[1] = c1(*this);
idx[2] = c2(*this);
return idx;
}
template <typename T>
std::vector<unsigned long> AbsNtuple<T>::columnIndices(const Column& c0,
const Column& c1,
const Column& c2,
const Column& c3) const
{
std::vector<unsigned long> idx(4);
idx[0] = c0(*this);
idx[1] = c1(*this);
idx[2] = c2(*this);
idx[3] = c3(*this);
return idx;
}
template <typename T>
std::vector<unsigned long> AbsNtuple<T>::columnIndices(const Column& c0,
const Column& c1,
const Column& c2,
const Column& c3,
const Column& c4) const
{
std::vector<unsigned long> idx(5);
idx[0] = c0(*this);
idx[1] = c1(*this);
idx[2] = c2(*this);
idx[3] = c3(*this);
idx[4] = c4(*this);
return idx;
}
template <typename T>
std::vector<unsigned long> AbsNtuple<T>::columnIndices(const Column& c0,
const Column& c1,
const Column& c2,
const Column& c3,
const Column& c4,
const Column& c5) const
{
std::vector<unsigned long> idx(6);
idx[0] = c0(*this);
idx[1] = c1(*this);
idx[2] = c2(*this);
idx[3] = c3(*this);
idx[4] = c4(*this);
idx[5] = c5(*this);
return idx;
}
template <typename T>
std::vector<unsigned long> AbsNtuple<T>::columnIndices(const Column& c0,
const Column& c1,
const Column& c2,
const Column& c3,
const Column& c4,
const Column& c5,
const Column& c6) const
{
std::vector<unsigned long> idx(7);
idx[0] = c0(*this);
idx[1] = c1(*this);
idx[2] = c2(*this);
idx[3] = c3(*this);
idx[4] = c4(*this);
idx[5] = c5(*this);
idx[6] = c6(*this);
return idx;
}
template <typename T>
std::vector<unsigned long> AbsNtuple<T>::columnIndices(const Column& c0,
const Column& c1,
const Column& c2,
const Column& c3,
const Column& c4,
const Column& c5,
const Column& c6,
const Column& c7) const
{
std::vector<unsigned long> idx(8);
idx[0] = c0(*this);
idx[1] = c1(*this);
idx[2] = c2(*this);
idx[3] = c3(*this);
idx[4] = c4(*this);
idx[5] = c5(*this);
idx[6] = c6(*this);
idx[7] = c7(*this);
return idx;
}
template <typename T>
std::vector<unsigned long> AbsNtuple<T>::columnIndices(const Column& c0,
const Column& c1,
const Column& c2,
const Column& c3,
const Column& c4,
const Column& c5,
const Column& c6,
const Column& c7,
const Column& c8) const
{
std::vector<unsigned long> idx(9);
idx[0] = c0(*this);
idx[1] = c1(*this);
idx[2] = c2(*this);
idx[3] = c3(*this);
idx[4] = c4(*this);
idx[5] = c5(*this);
idx[6] = c6(*this);
idx[7] = c7(*this);
idx[8] = c8(*this);
return idx;
}
template <typename T>
std::vector<unsigned long> AbsNtuple<T>::columnIndices(const Column& c0,
const Column& c1,
const Column& c2,
const Column& c3,
const Column& c4,
const Column& c5,
const Column& c6,
const Column& c7,
const Column& c8,
const Column& c9) const
{
std::vector<unsigned long> idx(10);
idx[0] = c0(*this);
idx[1] = c1(*this);
idx[2] = c2(*this);
idx[3] = c3(*this);
idx[4] = c4(*this);
idx[5] = c5(*this);
idx[6] = c6(*this);
idx[7] = c7(*this);
idx[8] = c8(*this);
idx[9] = c9(*this);
return idx;
}
template <typename T>
std::vector<unsigned long> AbsNtuple<T>::columnIndices(
const std::vector<std::string>& names) const
{
const unsigned long n = names.size();
std::vector<unsigned long> cvec(n);
for (unsigned long i=0; i<n; ++i)
cvec[i] = validColumn(names[i].c_str());
return cvec;
}
template <typename T>
bool dumpNtupleAsText(const AbsNtuple<T>& nt,
std::ostream& asciiStream,
const bool insertCommasBetweenValues,
const unsigned long firstRowToDump,
const unsigned long nRowsToDump)
{
if (nRowsToDump)
{
const unsigned long nR = nt.nRows();
if (firstRowToDump < nR)
{
const unsigned long nCols = nt.nColumns();
std::vector<T> bufVec(nCols);
T* buf = &bufVec[0];
unsigned long ndumped = 0;
for (unsigned long irow=firstRowToDump;
irow<nR && ndumped<nRowsToDump; ++irow, ++ndumped)
{
nt.rowContents(irow, buf, nCols);
asciiStream << buf[0];
for (unsigned long icol=1UL; icol<nCols; ++icol)
{
if (insertCommasBetweenValues)
asciiStream << ',';
asciiStream << ' ' << buf[icol];
}
asciiStream << '\n';
}
if (asciiStream.fail())
return false;
}
}
return true;
}
template <typename T>
bool fillNtupleFromText(std::istream& asciiStream,
AbsNtuple<T>* ntuple,
const bool hasCommasBetweenValues,
const unsigned long maxRowsToFill)
{
bool status = true;
- if (maxRowsToFill)
+ if (maxRowsToFill && asciiStream)
{
assert(ntuple);
const unsigned long nCols = ntuple->nColumns();
std::vector<T> bufVec(nCols);
T* buf = &bufVec[0];
std::string linebuf;
std::istringstream is;
unsigned long nfilled = 0;
while (asciiStream && status && nfilled<maxRowsToFill)
{
std::getline(asciiStream, linebuf);
const unsigned long len = linebuf.size();
if (len == 0UL)
continue;
// Ignore lines which are pure white space
// or which start with an arbitrary number
// of white space characters followed by #.
bool isComment = false;
bool allSpace = true;
char* line = &linebuf[0];
for (unsigned long i=0; i<len; ++i)
{
// For now, we will be simply converting commas
// into white space. Note that this is not
// necessarily correct for non-numeric types.
if (hasCommasBetweenValues)
if (line[i] == ',')
line[i] = ' ';
if (isspace(line[i]))
continue;
if (allSpace && line[i] == '#')
{
isComment = true;
break;
}
allSpace = false;
}
if (isComment || allSpace)
continue;
// Read the data into the buffer
is.str(linebuf);
is.clear();
for (unsigned long icol=0; icol<nCols; ++icol)
{
is >> buf[icol];
if (is.fail())
{
status = false;
break;
}
}
// Fill the ntuple
if (status)
{
ntuple->fill(buf, nCols);
++nfilled;
}
}
if ((asciiStream.fail() && !asciiStream.eof()) ||
asciiStream.bad())
status = false;
}
return status;
}
}
Index: trunk/config.log
===================================================================
--- trunk/config.log (revision 876)
+++ trunk/config.log (revision 877)
@@ -1,1181 +1,1181 @@
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.9.0, which was
generated by GNU Autoconf 2.71. Invocation command line was
$ ./configure --disable-static --with-pic
## --------- ##
## Platform. ##
## --------- ##
hostname = dawn
uname -m = x86_64
-uname -r = 5.15.0-56-generic
+uname -r = 5.15.0-58-generic
uname -s = Linux
-uname -v = #62-Ubuntu SMP Tue Nov 22 19:54:14 UTC 2022
+uname -v = #64-Ubuntu SMP Thu Jan 5 11:43:13 UTC 2023
/usr/bin/uname -p = x86_64
/bin/uname -X = unknown
/bin/arch = x86_64
/usr/bin/arch -k = unknown
/usr/convex/getsysinfo = unknown
/usr/bin/hostinfo = unknown
/bin/machine = unknown
/usr/bin/oslevel = unknown
/bin/universe = unknown
PATH: /home/igv/bin/
PATH: /home/igv/local/bin/
PATH: /usr/local/anaconda3/bin/
PATH: /usr/local/bin/
PATH: /usr/local/root/bin/
PATH: /usr/local/bin/
PATH: /bin/
PATH: /usr/bin/
PATH: /sbin/
PATH: /usr/sbin/
PATH: ./
## ----------- ##
## Core tests. ##
## ----------- ##
configure:2816: looking for aux files: compile ltmain.sh config.guess config.sub missing install-sh
configure:2829: trying ./
configure:2858: ./compile found
configure:2858: ./ltmain.sh found
configure:2858: ./config.guess found
configure:2858: ./config.sub found
configure:2858: ./missing found
configure:2840: ./install-sh found
configure:2988: checking for a BSD-compatible install
configure:3061: result: /bin/install -c
configure:3072: checking whether build environment is sane
configure:3127: result: yes
configure:3286: checking for a race-free mkdir -p
configure:3330: result: /bin/mkdir -p
configure:3337: checking for gawk
configure:3372: result: no
configure:3337: checking for mawk
configure:3358: found /bin/mawk
configure:3369: result: mawk
configure:3380: checking whether make sets $(MAKE)
configure:3403: result: yes
configure:3433: checking whether make supports nested variables
configure:3451: result: yes
configure:3650: checking for pkg-config
configure:3673: found /bin/pkg-config
configure:3685: result: /bin/pkg-config
configure:3710: checking pkg-config is at least version 0.9.0
configure:3713: result: yes
configure:3723: checking for fftw3 >= 3.1.2 geners >= 1.3.0 kstest >= 2.0.0
configure:3730: $PKG_CONFIG --exists --print-errors "fftw3 >= 3.1.2 geners >= 1.3.0 kstest >= 2.0.0"
configure:3733: $? = 0
configure:3747: $PKG_CONFIG --exists --print-errors "fftw3 >= 3.1.2 geners >= 1.3.0 kstest >= 2.0.0"
configure:3750: $? = 0
configure:3808: result: yes
configure:3882: checking for g++
configure:3903: found /bin/g++
configure:3914: result: g++
configure:3941: checking for C++ compiler version
configure:3950: g++ --version >&5
g++ (Ubuntu 11.3.0-1ubuntu1~22.04) 11.3.0
Copyright (C) 2021 Free Software Foundation, Inc.
This is free software; see the source for copying conditions. There is NO
warranty; not even for MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE.
configure:3961: $? = 0
configure:3950: g++ -v >&5
Using built-in specs.
COLLECT_GCC=g++
COLLECT_LTO_WRAPPER=/usr/lib/gcc/x86_64-linux-gnu/11/lto-wrapper
OFFLOAD_TARGET_NAMES=nvptx-none:amdgcn-amdhsa
OFFLOAD_TARGET_DEFAULT=1
Target: x86_64-linux-gnu
Configured with: ../src/configure -v --with-pkgversion='Ubuntu 11.3.0-1ubuntu1~22.04' --with-bugurl=file:///usr/share/doc/gcc-11/README.Bugs --enable-languages=c,ada,c++,go,brig,d,fortran,objc,obj-c++,m2 --prefix=/usr --with-gcc-major-version-only --program-suffix=-11 --program-prefix=x86_64-linux-gnu- --enable-shared --enable-linker-build-id --libexecdir=/usr/lib --without-included-gettext --enable-threads=posix --libdir=/usr/lib --enable-nls --enable-bootstrap --enable-clocale=gnu --enable-libstdcxx-debug --enable-libstdcxx-time=yes --with-default-libstdcxx-abi=new --enable-gnu-unique-object --disable-vtable-verify --enable-plugin --enable-default-pie --with-system-zlib --enable-libphobos-checking=release --with-target-system-zlib=auto --enable-objc-gc=auto --enable-multiarch --disable-werror --enable-cet --with-arch-32=i686 --with-abi=m64 --with-multilib-list=m32,m64,mx32 --enable-multilib --with-tune=generic --enable-offload-targets=nvptx-none=/build/gcc-11-xKiWfi/gcc-11-11.3.0/debian/tmp-nvptx/usr,amdgcn-amdhsa=/build/gcc-11-xKiWfi/gcc-11-11.3.0/debian/tmp-gcn/usr --without-cuda-driver --enable-checking=release --build=x86_64-linux-gnu --host=x86_64-linux-gnu --target=x86_64-linux-gnu --with-build-config=bootstrap-lto-lean --enable-link-serialization=2
Thread model: posix
Supported LTO compression algorithms: zlib zstd
gcc version 11.3.0 (Ubuntu 11.3.0-1ubuntu1~22.04)
... rest of stderr output deleted ...
configure:3961: $? = 0
configure:3950: g++ -V >&5
g++: error: unrecognized command-line option '-V'
g++: fatal error: no input files
compilation terminated.
configure:3961: $? = 1
configure:3950: g++ -qversion >&5
g++: error: unrecognized command-line option '-qversion'; did you mean '--version'?
g++: fatal error: no input files
compilation terminated.
configure:3961: $? = 1
configure:3981: checking whether the C++ compiler works
configure:4003: g++ -std=c++11 -O3 -Wall -W -Werror conftest.cpp >&5
configure:4007: $? = 0
configure:4057: result: yes
configure:4060: checking for C++ compiler default output file name
configure:4062: result: a.out
configure:4068: checking for suffix of executables
configure:4075: g++ -o conftest -std=c++11 -O3 -Wall -W -Werror conftest.cpp >&5
configure:4079: $? = 0
configure:4102: result:
configure:4124: checking whether we are cross compiling
configure:4132: g++ -o conftest -std=c++11 -O3 -Wall -W -Werror conftest.cpp >&5
configure:4136: $? = 0
configure:4143: ./conftest
configure:4147: $? = 0
configure:4162: result: no
configure:4167: checking for suffix of object files
configure:4190: g++ -c -std=c++11 -O3 -Wall -W -Werror conftest.cpp >&5
configure:4194: $? = 0
configure:4216: result: o
configure:4220: checking whether the compiler supports GNU C++
configure:4240: g++ -c -std=c++11 -O3 -Wall -W -Werror conftest.cpp >&5
configure:4240: $? = 0
configure:4250: result: yes
configure:4261: checking whether g++ accepts -g
configure:4282: g++ -c -g conftest.cpp >&5
configure:4282: $? = 0
configure:4326: result: yes
configure:4346: checking for g++ option to enable C++11 features
configure:4361: g++ -c -std=c++11 -O3 -Wall -W -Werror conftest.cpp >&5
conftest.cpp: In function 'int main(int, char**)':
conftest.cpp:134:8: error: unused variable 'a1' [-Werror=unused-variable]
134 | auto a1 = 6538;
| ^~
conftest.cpp:141:16: error: unused variable 'a4' [-Werror=unused-variable]
141 | decltype(a2) a4 = 34895.034;
| ^~
conftest.cpp:145:9: error: unused variable 'sa' [-Werror=unused-variable]
145 | short sa[cxx11test::get_val()] = { 0 };
| ^~
conftest.cpp:149:23: error: unused variable 'il' [-Werror=unused-variable]
149 | cxx11test::testinit il = { 4323, 435234.23544 };
| ^~
conftest.cpp:170:8: error: unused variable 'a' [-Werror=unused-variable]
170 | auto a = sum(1);
| ^
conftest.cpp:171:8: error: unused variable 'b' [-Werror=unused-variable]
171 | auto b = sum(1, 2);
| ^
conftest.cpp:172:8: error: unused variable 'c' [-Werror=unused-variable]
172 | auto c = sum(1.0, 2.0, 3.0);
| ^
conftest.cpp:177:25: error: empty parentheses were disambiguated as a function declaration [-Werror=vexing-parse]
177 | cxx11test::delegate d2();
| ^~
conftest.cpp:177:25: note: remove parentheses to default-initialize a variable
177 | cxx11test::delegate d2();
| ^~
| --
conftest.cpp:177:25: note: or replace parentheses with braces to value-initialize a variable
conftest.cpp:186:9: error: unused variable 'c' [-Werror=unused-variable]
186 | char *c = nullptr;
| ^
conftest.cpp:194:15: error: unused variable 'utf8' [-Werror=unused-variable]
194 | char const *utf8 = u8"UTF-8 string \u2500";
| ^~~~
conftest.cpp:195:19: error: unused variable 'utf16' [-Werror=unused-variable]
195 | char16_t const *utf16 = u"UTF-8 string \u2500";
| ^~~~~
conftest.cpp:196:19: error: unused variable 'utf32' [-Werror=unused-variable]
196 | char32_t const *utf32 = U"UTF-32 string \u2500";
| ^~~~~
cc1plus: all warnings being treated as errors
configure:4361: $? = 1
configure: failed program was:
| /* confdefs.h */
| #define PACKAGE_NAME "npstat"
| #define PACKAGE_TARNAME "npstat"
| #define PACKAGE_VERSION "5.9.0"
| #define PACKAGE_STRING "npstat 5.9.0"
| #define PACKAGE_BUGREPORT ""
| #define PACKAGE_URL ""
| #define PACKAGE "npstat"
| #define VERSION "5.9.0"
| /* end confdefs.h. */
|
| // Does the compiler advertise C++98 conformance?
| #if !defined __cplusplus || __cplusplus < 199711L
| # error "Compiler does not advertise C++98 conformance"
| #endif
|
| // These inclusions are to reject old compilers that
| // lack the unsuffixed header files.
| #include <cstdlib>
| #include <exception>
|
| // <cassert> and <cstring> are *not* freestanding headers in C++98.
| extern void assert (int);
| namespace std {
| extern int strcmp (const char *, const char *);
| }
|
| // Namespaces, exceptions, and templates were all added after "C++ 2.0".
| using std::exception;
| using std::strcmp;
|
| namespace {
|
| void test_exception_syntax()
| {
| try {
| throw "test";
| } catch (const char *s) {
| // Extra parentheses suppress a warning when building autoconf itself,
| // due to lint rules shared with more typical C programs.
| assert (!(strcmp) (s, "test"));
| }
| }
|
| template <typename T> struct test_template
| {
| T const val;
| explicit test_template(T t) : val(t) {}
| template <typename U> T add(U u) { return static_cast<T>(u) + val; }
| };
|
| } // anonymous namespace
|
|
| // Does the compiler advertise C++ 2011 conformance?
| #if !defined __cplusplus || __cplusplus < 201103L
| # error "Compiler does not advertise C++11 conformance"
| #endif
|
| namespace cxx11test
| {
| constexpr int get_val() { return 20; }
|
| struct testinit
| {
| int i;
| double d;
| };
|
| class delegate
| {
| public:
| delegate(int n) : n(n) {}
| delegate(): delegate(2354) {}
|
| virtual int getval() { return this->n; };
| protected:
| int n;
| };
|
| class overridden : public delegate
| {
| public:
| overridden(int n): delegate(n) {}
| virtual int getval() override final { return this->n * 2; }
| };
|
| class nocopy
| {
| public:
| nocopy(int i): i(i) {}
| nocopy() = default;
| nocopy(const nocopy&) = delete;
| nocopy & operator=(const nocopy&) = delete;
| private:
| int i;
| };
|
| // for testing lambda expressions
| template <typename Ret, typename Fn> Ret eval(Fn f, Ret v)
| {
| return f(v);
| }
|
| // for testing variadic templates and trailing return types
| template <typename V> auto sum(V first) -> V
| {
| return first;
| }
| template <typename V, typename... Args> auto sum(V first, Args... rest) -> V
| {
| return first + sum(rest...);
| }
| }
|
|
| int
| main (int argc, char **argv)
| {
| int ok = 0;
|
| assert (argc);
| assert (! argv[0]);
| {
| test_exception_syntax ();
| test_template<double> tt (2.0);
| assert (tt.add (4) == 6.0);
| assert (true && !false);
| }
|
|
| {
| // Test auto and decltype
| auto a1 = 6538;
| auto a2 = 48573953.4;
| auto a3 = "String literal";
|
| int total = 0;
| for (auto i = a3; *i; ++i) { total += *i; }
|
| decltype(a2) a4 = 34895.034;
| }
| {
| // Test constexpr
| short sa[cxx11test::get_val()] = { 0 };
| }
| {
| // Test initializer lists
| cxx11test::testinit il = { 4323, 435234.23544 };
| }
| {
| // Test range-based for
| int array[] = {9, 7, 13, 15, 4, 18, 12, 10, 5, 3,
| 14, 19, 17, 8, 6, 20, 16, 2, 11, 1};
| for (auto &x : array) { x += 23; }
| }
| {
| // Test lambda expressions
| using cxx11test::eval;
| assert (eval ([](int x) { return x*2; }, 21) == 42);
| double d = 2.0;
| assert (eval ([&](double x) { return d += x; }, 3.0) == 5.0);
| assert (d == 5.0);
| assert (eval ([=](double x) mutable { return d += x; }, 4.0) == 9.0);
| assert (d == 5.0);
| }
| {
| // Test use of variadic templates
| using cxx11test::sum;
| auto a = sum(1);
| auto b = sum(1, 2);
| auto c = sum(1.0, 2.0, 3.0);
| }
| {
| // Test constructor delegation
| cxx11test::delegate d1;
| cxx11test::delegate d2();
| cxx11test::delegate d3(45);
| }
| {
| // Test override and final
| cxx11test::overridden o1(55464);
| }
| {
| // Test nullptr
| char *c = nullptr;
| }
| {
| // Test template brackets
| test_template<::test_template<int>> v(test_template<int>(12));
| }
| {
| // Unicode literals
| char const *utf8 = u8"UTF-8 string \u2500";
| char16_t const *utf16 = u"UTF-8 string \u2500";
| char32_t const *utf32 = U"UTF-32 string \u2500";
| }
|
| return ok;
| }
|
configure:4379: result: none needed
configure:4446: checking whether make supports the include directive
configure:4461: make -f confmf.GNU && cat confinc.out
this is the am__doit target
configure:4464: $? = 0
configure:4483: result: yes (GNU style)
configure:4509: checking dependency style of g++
configure:4621: result: gcc3
configure:4695: checking for g77
configure:4716: found /home/igv/bin/g77
configure:4727: result: g77
configure:4753: checking for Fortran 77 compiler version
configure:4762: g77 --version >&5
GNU Fortran (Ubuntu 11.3.0-1ubuntu1~22.04) 11.3.0
Copyright (C) 2021 Free Software Foundation, Inc.
This is free software; see the source for copying conditions. There is NO
warranty; not even for MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE.
configure:4773: $? = 0
configure:4762: g77 -v >&5
Using built-in specs.
COLLECT_GCC=g77
COLLECT_LTO_WRAPPER=/usr/lib/gcc/x86_64-linux-gnu/11/lto-wrapper
OFFLOAD_TARGET_NAMES=nvptx-none:amdgcn-amdhsa
OFFLOAD_TARGET_DEFAULT=1
Target: x86_64-linux-gnu
Configured with: ../src/configure -v --with-pkgversion='Ubuntu 11.3.0-1ubuntu1~22.04' --with-bugurl=file:///usr/share/doc/gcc-11/README.Bugs --enable-languages=c,ada,c++,go,brig,d,fortran,objc,obj-c++,m2 --prefix=/usr --with-gcc-major-version-only --program-suffix=-11 --program-prefix=x86_64-linux-gnu- --enable-shared --enable-linker-build-id --libexecdir=/usr/lib --without-included-gettext --enable-threads=posix --libdir=/usr/lib --enable-nls --enable-bootstrap --enable-clocale=gnu --enable-libstdcxx-debug --enable-libstdcxx-time=yes --with-default-libstdcxx-abi=new --enable-gnu-unique-object --disable-vtable-verify --enable-plugin --enable-default-pie --with-system-zlib --enable-libphobos-checking=release --with-target-system-zlib=auto --enable-objc-gc=auto --enable-multiarch --disable-werror --enable-cet --with-arch-32=i686 --with-abi=m64 --with-multilib-list=m32,m64,mx32 --enable-multilib --with-tune=generic --enable-offload-targets=nvptx-none=/build/gcc-11-xKiWfi/gcc-11-11.3.0/debian/tmp-nvptx/usr,amdgcn-amdhsa=/build/gcc-11-xKiWfi/gcc-11-11.3.0/debian/tmp-gcn/usr --without-cuda-driver --enable-checking=release --build=x86_64-linux-gnu --host=x86_64-linux-gnu --target=x86_64-linux-gnu --with-build-config=bootstrap-lto-lean --enable-link-serialization=2
Thread model: posix
Supported LTO compression algorithms: zlib zstd
gcc version 11.3.0 (Ubuntu 11.3.0-1ubuntu1~22.04)
... rest of stderr output deleted ...
configure:4773: $? = 0
configure:4762: g77 -V >&5
g77: error: unrecognized command-line option '-V'
g77: fatal error: no input files
compilation terminated.
configure:4773: $? = 1
configure:4762: g77 -qversion >&5
g77: error: unrecognized command-line option '-qversion'; did you mean '--version'?
g77: fatal error: no input files
compilation terminated.
configure:4773: $? = 1
configure:4782: checking whether the compiler supports GNU Fortran 77
configure:4796: g77 -c conftest.F >&5
configure:4796: $? = 0
configure:4806: result: yes
configure:4814: checking whether g77 accepts -g
configure:4826: g77 -c -g conftest.f >&5
configure:4826: $? = 0
configure:4835: result: yes
configure:4870: checking build system type
configure:4885: result: x86_64-pc-linux-gnu
configure:4905: checking host system type
configure:4919: result: x86_64-pc-linux-gnu
configure:4944: checking how to get verbose linking output from g77
configure:4955: g77 -c -g -O2 conftest.f >&5
configure:4955: $? = 0
configure:4974: g77 -o conftest -g -O2 -v conftest.f
Using built-in specs.
Target: x86_64-linux-gnu
Thread model: posix
Supported LTO compression algorithms: zlib zstd
gcc version 11.3.0 (Ubuntu 11.3.0-1ubuntu1~22.04)
- /usr/lib/gcc/x86_64-linux-gnu/11/f951 conftest.f -ffixed-form -quiet -dumpbase conftest.f -dumpbase-ext .f -mtune=generic -march=x86-64 -g -O2 -version -fintrinsic-modules-path /usr/lib/gcc/x86_64-linux-gnu/11/finclude -fpre-include=/usr/include/finclude/math-vector-fortran.h -o /tmp/ccWjsJMr.s
+ /usr/lib/gcc/x86_64-linux-gnu/11/f951 conftest.f -ffixed-form -quiet -dumpbase conftest.f -dumpbase-ext .f -mtune=generic -march=x86-64 -g -O2 -version -fintrinsic-modules-path /usr/lib/gcc/x86_64-linux-gnu/11/finclude -fpre-include=/usr/include/finclude/math-vector-fortran.h -o /tmp/ccMTPnSy.s
GNU Fortran (Ubuntu 11.3.0-1ubuntu1~22.04) version 11.3.0 (x86_64-linux-gnu)
compiled by GNU C version 11.3.0, GMP version 6.2.1, MPFR version 4.1.0, MPC version 1.2.1, isl version isl-0.24-GMP
GGC heuristics: --param ggc-min-expand=100 --param ggc-min-heapsize=131072
GNU Fortran2008 (Ubuntu 11.3.0-1ubuntu1~22.04) version 11.3.0 (x86_64-linux-gnu)
compiled by GNU C version 11.3.0, GMP version 6.2.1, MPFR version 4.1.0, MPC version 1.2.1, isl version isl-0.24-GMP
GGC heuristics: --param ggc-min-expand=100 --param ggc-min-heapsize=131072
- as -v --gdwarf-5 --64 -o /tmp/ccFN6cOU.o /tmp/ccWjsJMr.s
+ as -v --gdwarf-5 --64 -o /tmp/ccZQ0nGw.o /tmp/ccMTPnSy.s
GNU assembler version 2.38 (x86_64-linux-gnu) using BFD version (GNU Binutils for Ubuntu) 2.38
Reading specs from /usr/lib/gcc/x86_64-linux-gnu/11/libgfortran.spec
rename spec lib to liborig
- /usr/lib/gcc/x86_64-linux-gnu/11/collect2 -plugin /usr/lib/gcc/x86_64-linux-gnu/11/liblto_plugin.so -plugin-opt=/usr/lib/gcc/x86_64-linux-gnu/11/lto-wrapper -plugin-opt=-fresolution=/tmp/ccw5pLdT.res -plugin-opt=-pass-through=-lgcc_s -plugin-opt=-pass-through=-lgcc -plugin-opt=-pass-through=-lquadmath -plugin-opt=-pass-through=-lm -plugin-opt=-pass-through=-lgcc_s -plugin-opt=-pass-through=-lgcc -plugin-opt=-pass-through=-lc -plugin-opt=-pass-through=-lgcc_s -plugin-opt=-pass-through=-lgcc --build-id --eh-frame-hdr -m elf_x86_64 --hash-style=gnu --as-needed -dynamic-linker /lib64/ld-linux-x86-64.so.2 -pie -z now -z relro -o conftest /usr/lib/gcc/x86_64-linux-gnu/11/../../../x86_64-linux-gnu/Scrt1.o /usr/lib/gcc/x86_64-linux-gnu/11/../../../x86_64-linux-gnu/crti.o /usr/lib/gcc/x86_64-linux-gnu/11/crtbeginS.o -L/usr/lib/gcc/x86_64-linux-gnu/11 -L/usr/lib/gcc/x86_64-linux-gnu/11/../../../x86_64-linux-gnu -L/usr/lib/gcc/x86_64-linux-gnu/11/../../../../lib -L/lib/x86_64-linux-gnu -L/lib/../lib -L/usr/lib/x86_64-linux-gnu -L/usr/lib/../lib -L/usr/lib/gcc/x86_64-linux-gnu/11/../../.. /tmp/ccFN6cOU.o -lgfortran -lm -lgcc_s -lgcc -lquadmath -lm -lgcc_s -lgcc -lc -lgcc_s -lgcc /usr/lib/gcc/x86_64-linux-gnu/11/crtendS.o /usr/lib/gcc/x86_64-linux-gnu/11/../../../x86_64-linux-gnu/crtn.o
+ /usr/lib/gcc/x86_64-linux-gnu/11/collect2 -plugin /usr/lib/gcc/x86_64-linux-gnu/11/liblto_plugin.so -plugin-opt=/usr/lib/gcc/x86_64-linux-gnu/11/lto-wrapper -plugin-opt=-fresolution=/tmp/ccQ8uRLc.res -plugin-opt=-pass-through=-lgcc_s -plugin-opt=-pass-through=-lgcc -plugin-opt=-pass-through=-lquadmath -plugin-opt=-pass-through=-lm -plugin-opt=-pass-through=-lgcc_s -plugin-opt=-pass-through=-lgcc -plugin-opt=-pass-through=-lc -plugin-opt=-pass-through=-lgcc_s -plugin-opt=-pass-through=-lgcc --build-id --eh-frame-hdr -m elf_x86_64 --hash-style=gnu --as-needed -dynamic-linker /lib64/ld-linux-x86-64.so.2 -pie -z now -z relro -o conftest /usr/lib/gcc/x86_64-linux-gnu/11/../../../x86_64-linux-gnu/Scrt1.o /usr/lib/gcc/x86_64-linux-gnu/11/../../../x86_64-linux-gnu/crti.o /usr/lib/gcc/x86_64-linux-gnu/11/crtbeginS.o -L/usr/lib/gcc/x86_64-linux-gnu/11 -L/usr/lib/gcc/x86_64-linux-gnu/11/../../../x86_64-linux-gnu -L/usr/lib/gcc/x86_64-linux-gnu/11/../../../../lib -L/lib/x86_64-linux-gnu -L/lib/../lib -L/usr/lib/x86_64-linux-gnu -L/usr/lib/../lib -L/usr/lib/gcc/x86_64-linux-gnu/11/../../.. /tmp/ccZQ0nGw.o -lgfortran -lm -lgcc_s -lgcc -lquadmath -lm -lgcc_s -lgcc -lc -lgcc_s -lgcc /usr/lib/gcc/x86_64-linux-gnu/11/crtendS.o /usr/lib/gcc/x86_64-linux-gnu/11/../../../x86_64-linux-gnu/crtn.o
configure:5057: result: -v
configure:5059: checking for Fortran 77 libraries of g77
configure:5083: g77 -o conftest -g -O2 -v conftest.f
Using built-in specs.
Target: x86_64-linux-gnu
Thread model: posix
Supported LTO compression algorithms: zlib zstd
gcc version 11.3.0 (Ubuntu 11.3.0-1ubuntu1~22.04)
- /usr/lib/gcc/x86_64-linux-gnu/11/f951 conftest.f -ffixed-form -quiet -dumpbase conftest.f -dumpbase-ext .f -mtune=generic -march=x86-64 -g -O2 -version -fintrinsic-modules-path /usr/lib/gcc/x86_64-linux-gnu/11/finclude -fpre-include=/usr/include/finclude/math-vector-fortran.h -o /tmp/ccbusmi8.s
+ /usr/lib/gcc/x86_64-linux-gnu/11/f951 conftest.f -ffixed-form -quiet -dumpbase conftest.f -dumpbase-ext .f -mtune=generic -march=x86-64 -g -O2 -version -fintrinsic-modules-path /usr/lib/gcc/x86_64-linux-gnu/11/finclude -fpre-include=/usr/include/finclude/math-vector-fortran.h -o /tmp/ccaOq8Qh.s
GNU Fortran (Ubuntu 11.3.0-1ubuntu1~22.04) version 11.3.0 (x86_64-linux-gnu)
compiled by GNU C version 11.3.0, GMP version 6.2.1, MPFR version 4.1.0, MPC version 1.2.1, isl version isl-0.24-GMP
GGC heuristics: --param ggc-min-expand=100 --param ggc-min-heapsize=131072
GNU Fortran2008 (Ubuntu 11.3.0-1ubuntu1~22.04) version 11.3.0 (x86_64-linux-gnu)
compiled by GNU C version 11.3.0, GMP version 6.2.1, MPFR version 4.1.0, MPC version 1.2.1, isl version isl-0.24-GMP
GGC heuristics: --param ggc-min-expand=100 --param ggc-min-heapsize=131072
- as -v --gdwarf-5 --64 -o /tmp/ccoriLdo.o /tmp/ccbusmi8.s
+ as -v --gdwarf-5 --64 -o /tmp/cc1aLT13.o /tmp/ccaOq8Qh.s
GNU assembler version 2.38 (x86_64-linux-gnu) using BFD version (GNU Binutils for Ubuntu) 2.38
Reading specs from /usr/lib/gcc/x86_64-linux-gnu/11/libgfortran.spec
rename spec lib to liborig
- /usr/lib/gcc/x86_64-linux-gnu/11/collect2 -plugin /usr/lib/gcc/x86_64-linux-gnu/11/liblto_plugin.so -plugin-opt=/usr/lib/gcc/x86_64-linux-gnu/11/lto-wrapper -plugin-opt=-fresolution=/tmp/cc2cdFKx.res -plugin-opt=-pass-through=-lgcc_s -plugin-opt=-pass-through=-lgcc -plugin-opt=-pass-through=-lquadmath -plugin-opt=-pass-through=-lm -plugin-opt=-pass-through=-lgcc_s -plugin-opt=-pass-through=-lgcc -plugin-opt=-pass-through=-lc -plugin-opt=-pass-through=-lgcc_s -plugin-opt=-pass-through=-lgcc --build-id --eh-frame-hdr -m elf_x86_64 --hash-style=gnu --as-needed -dynamic-linker /lib64/ld-linux-x86-64.so.2 -pie -z now -z relro -o conftest /usr/lib/gcc/x86_64-linux-gnu/11/../../../x86_64-linux-gnu/Scrt1.o /usr/lib/gcc/x86_64-linux-gnu/11/../../../x86_64-linux-gnu/crti.o /usr/lib/gcc/x86_64-linux-gnu/11/crtbeginS.o -L/usr/lib/gcc/x86_64-linux-gnu/11 -L/usr/lib/gcc/x86_64-linux-gnu/11/../../../x86_64-linux-gnu -L/usr/lib/gcc/x86_64-linux-gnu/11/../../../../lib -L/lib/x86_64-linux-gnu -L/lib/../lib -L/usr/lib/x86_64-linux-gnu -L/usr/lib/../lib -L/usr/lib/gcc/x86_64-linux-gnu/11/../../.. /tmp/ccoriLdo.o -lgfortran -lm -lgcc_s -lgcc -lquadmath -lm -lgcc_s -lgcc -lc -lgcc_s -lgcc /usr/lib/gcc/x86_64-linux-gnu/11/crtendS.o /usr/lib/gcc/x86_64-linux-gnu/11/../../../x86_64-linux-gnu/crtn.o
+ /usr/lib/gcc/x86_64-linux-gnu/11/collect2 -plugin /usr/lib/gcc/x86_64-linux-gnu/11/liblto_plugin.so -plugin-opt=/usr/lib/gcc/x86_64-linux-gnu/11/lto-wrapper -plugin-opt=-fresolution=/tmp/cc6JrKGz.res -plugin-opt=-pass-through=-lgcc_s -plugin-opt=-pass-through=-lgcc -plugin-opt=-pass-through=-lquadmath -plugin-opt=-pass-through=-lm -plugin-opt=-pass-through=-lgcc_s -plugin-opt=-pass-through=-lgcc -plugin-opt=-pass-through=-lc -plugin-opt=-pass-through=-lgcc_s -plugin-opt=-pass-through=-lgcc --build-id --eh-frame-hdr -m elf_x86_64 --hash-style=gnu --as-needed -dynamic-linker /lib64/ld-linux-x86-64.so.2 -pie -z now -z relro -o conftest /usr/lib/gcc/x86_64-linux-gnu/11/../../../x86_64-linux-gnu/Scrt1.o /usr/lib/gcc/x86_64-linux-gnu/11/../../../x86_64-linux-gnu/crti.o /usr/lib/gcc/x86_64-linux-gnu/11/crtbeginS.o -L/usr/lib/gcc/x86_64-linux-gnu/11 -L/usr/lib/gcc/x86_64-linux-gnu/11/../../../x86_64-linux-gnu -L/usr/lib/gcc/x86_64-linux-gnu/11/../../../../lib -L/lib/x86_64-linux-gnu -L/lib/../lib -L/usr/lib/x86_64-linux-gnu -L/usr/lib/../lib -L/usr/lib/gcc/x86_64-linux-gnu/11/../../.. /tmp/cc1aLT13.o -lgfortran -lm -lgcc_s -lgcc -lquadmath -lm -lgcc_s -lgcc -lc -lgcc_s -lgcc /usr/lib/gcc/x86_64-linux-gnu/11/crtendS.o /usr/lib/gcc/x86_64-linux-gnu/11/../../../x86_64-linux-gnu/crtn.o
configure:5299: result: -L/usr/lib/gcc/x86_64-linux-gnu/11 -L/usr/lib/gcc/x86_64-linux-gnu/11/../../../x86_64-linux-gnu -L/usr/lib/gcc/x86_64-linux-gnu/11/../../../../lib -L/lib/x86_64-linux-gnu -L/lib/../lib -L/usr/lib/x86_64-linux-gnu -L/usr/lib/../lib -L/usr/lib/gcc/x86_64-linux-gnu/11/../../.. -lgfortran -lm -lquadmath
configure:5362: checking how to print strings
configure:5389: result: printf
configure:5472: checking for gcc
configure:5493: found /bin/gcc
configure:5504: result: gcc
configure:5857: checking for C compiler version
configure:5866: gcc --version >&5
gcc (Ubuntu 11.3.0-1ubuntu1~22.04) 11.3.0
Copyright (C) 2021 Free Software Foundation, Inc.
This is free software; see the source for copying conditions. There is NO
warranty; not even for MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE.
configure:5877: $? = 0
configure:5866: gcc -v >&5
Using built-in specs.
COLLECT_GCC=gcc
COLLECT_LTO_WRAPPER=/usr/lib/gcc/x86_64-linux-gnu/11/lto-wrapper
OFFLOAD_TARGET_NAMES=nvptx-none:amdgcn-amdhsa
OFFLOAD_TARGET_DEFAULT=1
Target: x86_64-linux-gnu
Configured with: ../src/configure -v --with-pkgversion='Ubuntu 11.3.0-1ubuntu1~22.04' --with-bugurl=file:///usr/share/doc/gcc-11/README.Bugs --enable-languages=c,ada,c++,go,brig,d,fortran,objc,obj-c++,m2 --prefix=/usr --with-gcc-major-version-only --program-suffix=-11 --program-prefix=x86_64-linux-gnu- --enable-shared --enable-linker-build-id --libexecdir=/usr/lib --without-included-gettext --enable-threads=posix --libdir=/usr/lib --enable-nls --enable-bootstrap --enable-clocale=gnu --enable-libstdcxx-debug --enable-libstdcxx-time=yes --with-default-libstdcxx-abi=new --enable-gnu-unique-object --disable-vtable-verify --enable-plugin --enable-default-pie --with-system-zlib --enable-libphobos-checking=release --with-target-system-zlib=auto --enable-objc-gc=auto --enable-multiarch --disable-werror --enable-cet --with-arch-32=i686 --with-abi=m64 --with-multilib-list=m32,m64,mx32 --enable-multilib --with-tune=generic --enable-offload-targets=nvptx-none=/build/gcc-11-xKiWfi/gcc-11-11.3.0/debian/tmp-nvptx/usr,amdgcn-amdhsa=/build/gcc-11-xKiWfi/gcc-11-11.3.0/debian/tmp-gcn/usr --without-cuda-driver --enable-checking=release --build=x86_64-linux-gnu --host=x86_64-linux-gnu --target=x86_64-linux-gnu --with-build-config=bootstrap-lto-lean --enable-link-serialization=2
Thread model: posix
Supported LTO compression algorithms: zlib zstd
gcc version 11.3.0 (Ubuntu 11.3.0-1ubuntu1~22.04)
... rest of stderr output deleted ...
configure:5877: $? = 0
configure:5866: gcc -V >&5
gcc: error: unrecognized command-line option '-V'
gcc: fatal error: no input files
compilation terminated.
configure:5877: $? = 1
configure:5866: gcc -qversion >&5
gcc: error: unrecognized command-line option '-qversion'; did you mean '--version'?
gcc: fatal error: no input files
compilation terminated.
configure:5877: $? = 1
configure:5866: gcc -version >&5
gcc: error: unrecognized command-line option '-version'
gcc: fatal error: no input files
compilation terminated.
configure:5877: $? = 1
configure:5881: checking whether the compiler supports GNU C
configure:5901: gcc -c conftest.c >&5
configure:5901: $? = 0
configure:5911: result: yes
configure:5922: checking whether gcc accepts -g
configure:5943: gcc -c -g conftest.c >&5
configure:5943: $? = 0
configure:5987: result: yes
configure:6007: checking for gcc option to enable C11 features
configure:6022: gcc -c -g -O2 conftest.c >&5
configure:6022: $? = 0
configure:6040: result: none needed
configure:6156: checking whether gcc understands -c and -o together
configure:6179: gcc -c conftest.c -o conftest2.o
configure:6182: $? = 0
configure:6179: gcc -c conftest.c -o conftest2.o
configure:6182: $? = 0
configure:6194: result: yes
configure:6213: checking dependency style of gcc
configure:6325: result: gcc3
configure:6340: checking for a sed that does not truncate output
configure:6410: result: /bin/sed
configure:6428: checking for grep that handles long lines and -e
configure:6492: result: /bin/grep
configure:6497: checking for egrep
configure:6565: result: /bin/grep -E
configure:6570: checking for fgrep
configure:6638: result: /bin/grep -F
configure:6674: checking for ld used by gcc
configure:6742: result: /bin/ld
configure:6749: checking if the linker (/bin/ld) is GNU ld
configure:6765: result: yes
configure:6777: checking for BSD- or MS-compatible name lister (nm)
configure:6832: result: /bin/nm -B
configure:6972: checking the name lister (/bin/nm -B) interface
configure:6980: gcc -c -g -O2 conftest.c >&5
configure:6983: /bin/nm -B "conftest.o"
configure:6986: output
0000000000000000 B some_variable
configure:6993: result: BSD nm
configure:6996: checking whether ln -s works
configure:7000: result: yes
configure:7008: checking the maximum length of command line arguments
configure:7140: result: 1572864
configure:7188: checking how to convert x86_64-pc-linux-gnu file names to x86_64-pc-linux-gnu format
configure:7229: result: func_convert_file_noop
configure:7236: checking how to convert x86_64-pc-linux-gnu file names to toolchain format
configure:7257: result: func_convert_file_noop
configure:7264: checking for /bin/ld option to reload object files
configure:7272: result: -r
configure:7351: checking for objdump
configure:7372: found /bin/objdump
configure:7383: result: objdump
configure:7415: checking how to recognize dependent libraries
configure:7616: result: pass_all
configure:7706: checking for dlltool
configure:7741: result: no
configure:7771: checking how to associate runtime and link libraries
configure:7799: result: printf %s\n
configure:7865: checking for ar
configure:7886: found /bin/ar
configure:7897: result: ar
configure:7934: checking for archiver @FILE support
configure:7952: gcc -c -g -O2 conftest.c >&5
configure:7952: $? = 0
configure:7956: ar cr libconftest.a @conftest.lst >&5
configure:7959: $? = 0
configure:7964: ar cr libconftest.a @conftest.lst >&5
ar: conftest.o: No such file or directory
configure:7967: $? = 1
configure:7979: result: @
configure:8042: checking for strip
configure:8063: found /bin/strip
configure:8074: result: strip
configure:8151: checking for ranlib
configure:8172: found /bin/ranlib
configure:8183: result: ranlib
configure:8285: checking command to parse /bin/nm -B output from gcc object
configure:8439: gcc -c -g -O2 conftest.c >&5
configure:8442: $? = 0
configure:8446: /bin/nm -B conftest.o | sed -n -e 's/^.*[ ]\([ABCDGIRSTW][ABCDGIRSTW]*\)[ ][ ]*\([_A-Za-z][_A-Za-z0-9]*\)$/\1 \2 \2/p' | sed '/ __gnu_lto/d' > conftest.nm
configure:8512: gcc -o conftest -g -O2 conftest.c conftstm.o >&5
configure:8515: $? = 0
configure:8553: result: ok
configure:8600: checking for sysroot
configure:8631: result: no
configure:8638: checking for a working dd
configure:8682: result: /bin/dd
configure:8686: checking how to truncate binary pipes
configure:8702: result: /bin/dd bs=4096 count=1
configure:8839: gcc -c -g -O2 conftest.c >&5
configure:8842: $? = 0
configure:9039: checking for mt
configure:9060: found /bin/mt
configure:9071: result: mt
configure:9094: checking if mt is a manifest tool
configure:9101: mt '-?'
configure:9109: result: no
configure:9839: checking for stdio.h
configure:9839: gcc -c -g -O2 conftest.c >&5
configure:9839: $? = 0
configure:9839: result: yes
configure:9839: checking for stdlib.h
configure:9839: gcc -c -g -O2 conftest.c >&5
configure:9839: $? = 0
configure:9839: result: yes
configure:9839: checking for string.h
configure:9839: gcc -c -g -O2 conftest.c >&5
configure:9839: $? = 0
configure:9839: result: yes
configure:9839: checking for inttypes.h
configure:9839: gcc -c -g -O2 conftest.c >&5
configure:9839: $? = 0
configure:9839: result: yes
configure:9839: checking for stdint.h
configure:9839: gcc -c -g -O2 conftest.c >&5
configure:9839: $? = 0
configure:9839: result: yes
configure:9839: checking for strings.h
configure:9839: gcc -c -g -O2 conftest.c >&5
configure:9839: $? = 0
configure:9839: result: yes
configure:9839: checking for sys/stat.h
configure:9839: gcc -c -g -O2 conftest.c >&5
configure:9839: $? = 0
configure:9839: result: yes
configure:9839: checking for sys/types.h
configure:9839: gcc -c -g -O2 conftest.c >&5
configure:9839: $? = 0
configure:9839: result: yes
configure:9839: checking for unistd.h
configure:9839: gcc -c -g -O2 conftest.c >&5
configure:9839: $? = 0
configure:9839: result: yes
configure:9864: checking for dlfcn.h
configure:9864: gcc -c -g -O2 conftest.c >&5
configure:9864: $? = 0
configure:9864: result: yes
configure:10134: checking for objdir
configure:10150: result: .libs
configure:10414: checking if gcc supports -fno-rtti -fno-exceptions
configure:10433: gcc -c -g -O2 -fno-rtti -fno-exceptions conftest.c >&5
cc1: warning: command-line option '-fno-rtti' is valid for C++/D/ObjC++ but not for C
configure:10437: $? = 0
configure:10450: result: no
configure:10814: checking for gcc option to produce PIC
configure:10822: result: -fPIC -DPIC
configure:10830: checking if gcc PIC flag -fPIC -DPIC works
configure:10849: gcc -c -g -O2 -fPIC -DPIC -DPIC conftest.c >&5
configure:10853: $? = 0
configure:10866: result: yes
configure:10895: checking if gcc static flag -static works
configure:10924: result: yes
configure:10939: checking if gcc supports -c -o file.o
configure:10961: gcc -c -g -O2 -o out/conftest2.o conftest.c >&5
configure:10965: $? = 0
configure:10987: result: yes
configure:10995: checking if gcc supports -c -o file.o
configure:11043: result: yes
configure:11076: checking whether the gcc linker (/bin/ld -m elf_x86_64) supports shared libraries
configure:12346: result: yes
configure:12383: checking whether -lc should be explicitly linked in
configure:12392: gcc -c -g -O2 conftest.c >&5
configure:12395: $? = 0
configure:12410: gcc -shared -fPIC -DPIC conftest.o -v -Wl,-soname -Wl,conftest -o conftest 2\>\&1 \| /bin/grep -lc \>/dev/null 2\>\&1
configure:12413: $? = 0
configure:12427: result: no
configure:12587: checking dynamic linker characteristics
configure:13169: gcc -o conftest -g -O2 -Wl,-rpath -Wl,/foo conftest.c >&5
configure:13169: $? = 0
configure:13420: result: GNU/Linux ld.so
configure:13542: checking how to hardcode library paths into programs
configure:13567: result: immediate
configure:14119: checking whether stripping libraries is possible
configure:14124: result: yes
configure:14159: checking if libtool supports shared libraries
configure:14161: result: yes
configure:14164: checking whether to build shared libraries
configure:14189: result: yes
configure:14192: checking whether to build static libraries
configure:14196: result: no
configure:14219: checking how to run the C++ preprocessor
configure:14241: g++ -E conftest.cpp
configure:14241: $? = 0
configure:14256: g++ -E conftest.cpp
conftest.cpp:23:10: fatal error: ac_nonexistent.h: No such file or directory
23 | #include <ac_nonexistent.h>
| ^~~~~~~~~~~~~~~~~~
compilation terminated.
configure:14256: $? = 1
configure: failed program was:
| /* confdefs.h */
| #define PACKAGE_NAME "npstat"
| #define PACKAGE_TARNAME "npstat"
| #define PACKAGE_VERSION "5.9.0"
| #define PACKAGE_STRING "npstat 5.9.0"
| #define PACKAGE_BUGREPORT ""
| #define PACKAGE_URL ""
| #define PACKAGE "npstat"
| #define VERSION "5.9.0"
| #define HAVE_STDIO_H 1
| #define HAVE_STDLIB_H 1
| #define HAVE_STRING_H 1
| #define HAVE_INTTYPES_H 1
| #define HAVE_STDINT_H 1
| #define HAVE_STRINGS_H 1
| #define HAVE_SYS_STAT_H 1
| #define HAVE_SYS_TYPES_H 1
| #define HAVE_UNISTD_H 1
| #define STDC_HEADERS 1
| #define HAVE_DLFCN_H 1
| #define LT_OBJDIR ".libs/"
| /* end confdefs.h. */
| #include <ac_nonexistent.h>
configure:14283: result: g++ -E
configure:14297: g++ -E conftest.cpp
configure:14297: $? = 0
configure:14312: g++ -E conftest.cpp
conftest.cpp:23:10: fatal error: ac_nonexistent.h: No such file or directory
23 | #include <ac_nonexistent.h>
| ^~~~~~~~~~~~~~~~~~
compilation terminated.
configure:14312: $? = 1
configure: failed program was:
| /* confdefs.h */
| #define PACKAGE_NAME "npstat"
| #define PACKAGE_TARNAME "npstat"
| #define PACKAGE_VERSION "5.9.0"
| #define PACKAGE_STRING "npstat 5.9.0"
| #define PACKAGE_BUGREPORT ""
| #define PACKAGE_URL ""
| #define PACKAGE "npstat"
| #define VERSION "5.9.0"
| #define HAVE_STDIO_H 1
| #define HAVE_STDLIB_H 1
| #define HAVE_STRING_H 1
| #define HAVE_INTTYPES_H 1
| #define HAVE_STDINT_H 1
| #define HAVE_STRINGS_H 1
| #define HAVE_SYS_STAT_H 1
| #define HAVE_SYS_TYPES_H 1
| #define HAVE_UNISTD_H 1
| #define STDC_HEADERS 1
| #define HAVE_DLFCN_H 1
| #define LT_OBJDIR ".libs/"
| /* end confdefs.h. */
| #include <ac_nonexistent.h>
configure:14477: checking for ld used by g++
configure:14545: result: /bin/ld -m elf_x86_64
configure:14552: checking if the linker (/bin/ld -m elf_x86_64) is GNU ld
configure:14568: result: yes
configure:14623: checking whether the g++ linker (/bin/ld -m elf_x86_64) supports shared libraries
configure:15700: result: yes
configure:15736: g++ -c -std=c++11 -O3 -Wall -W -Werror conftest.cpp >&5
configure:15739: $? = 0
configure:16220: checking for g++ option to produce PIC
configure:16228: result: -fPIC -DPIC
configure:16236: checking if g++ PIC flag -fPIC -DPIC works
configure:16255: g++ -c -std=c++11 -O3 -Wall -W -Werror -fPIC -DPIC -DPIC conftest.cpp >&5
configure:16259: $? = 0
configure:16272: result: yes
configure:16295: checking if g++ static flag -static works
configure:16324: result: yes
configure:16336: checking if g++ supports -c -o file.o
configure:16358: g++ -c -std=c++11 -O3 -Wall -W -Werror -o out/conftest2.o conftest.cpp >&5
configure:16362: $? = 0
configure:16384: result: yes
configure:16389: checking if g++ supports -c -o file.o
configure:16437: result: yes
configure:16467: checking whether the g++ linker (/bin/ld -m elf_x86_64) supports shared libraries
configure:16510: result: yes
configure:16652: checking dynamic linker characteristics
configure:17412: result: GNU/Linux ld.so
configure:17477: checking how to hardcode library paths into programs
configure:17502: result: immediate
configure:17643: checking if libtool supports shared libraries
configure:17645: result: yes
configure:17648: checking whether to build shared libraries
configure:17672: result: yes
configure:17675: checking whether to build static libraries
configure:17679: result: no
configure:18037: checking for g77 option to produce PIC
configure:18045: result: -fPIC
configure:18053: checking if g77 PIC flag -fPIC works
configure:18072: g77 -c -g -O2 -fPIC conftest.f >&5
configure:18076: $? = 0
configure:18089: result: yes
configure:18112: checking if g77 static flag -static works
configure:18141: result: yes
configure:18153: checking if g77 supports -c -o file.o
configure:18175: g77 -c -g -O2 -o out/conftest2.o conftest.f >&5
configure:18179: $? = 0
configure:18201: result: yes
configure:18206: checking if g77 supports -c -o file.o
configure:18254: result: yes
configure:18284: checking whether the g77 linker (/bin/ld -m elf_x86_64) supports shared libraries
configure:19503: result: yes
configure:19645: checking dynamic linker characteristics
configure:20399: result: GNU/Linux ld.so
configure:20464: checking how to hardcode library paths into programs
configure:20489: result: immediate
configure:20681: checking that generated files are newer than configure
configure:20687: result: done
configure:20714: creating ./config.status
## ---------------------- ##
## Running config.status. ##
## ---------------------- ##
This file was extended by npstat config.status 5.9.0, which was
generated by GNU Autoconf 2.71. Invocation command line was
CONFIG_FILES =
CONFIG_HEADERS =
CONFIG_LINKS =
CONFIG_COMMANDS =
$ ./config.status
on dawn
config.status:1138: creating Makefile
config.status:1138: creating npstat/nm/Makefile
config.status:1138: creating npstat/rng/Makefile
config.status:1138: creating npstat/stat/Makefile
config.status:1138: creating npstat/wrap/Makefile
config.status:1138: creating npstat/interfaces/Makefile
config.status:1138: creating npstat/emsunfold/Makefile
config.status:1138: creating npstat/Makefile
config.status:1138: creating examples/C++/Makefile
config.status:1138: creating npstat/swig/Makefile
config.status:1138: creating npstat.pc
config.status:1310: executing depfiles commands
config.status:1387: cd npstat/nm && sed -e '/# am--include-marker/d' Makefile | make -f - am--depfiles
make: Nothing to be done for 'am--depfiles'.
config.status:1392: $? = 0
config.status:1387: cd npstat/rng && sed -e '/# am--include-marker/d' Makefile | make -f - am--depfiles
make: Nothing to be done for 'am--depfiles'.
config.status:1392: $? = 0
config.status:1387: cd npstat/stat && sed -e '/# am--include-marker/d' Makefile | make -f - am--depfiles
make: Nothing to be done for 'am--depfiles'.
config.status:1392: $? = 0
config.status:1387: cd examples/C++ && sed -e '/# am--include-marker/d' Makefile | make -f - am--depfiles
make: Nothing to be done for 'am--depfiles'.
config.status:1392: $? = 0
config.status:1387: cd npstat/swig && sed -e '/# am--include-marker/d' Makefile | make -f - am--depfiles
make: Nothing to be done for 'am--depfiles'.
config.status:1392: $? = 0
config.status:1310: executing libtool commands
## ---------------- ##
## Cache variables. ##
## ---------------- ##
ac_cv_build=x86_64-pc-linux-gnu
ac_cv_c_compiler_gnu=yes
ac_cv_cxx_compiler_gnu=yes
ac_cv_env_CCC_set=
ac_cv_env_CCC_value=
ac_cv_env_CC_set=
ac_cv_env_CC_value=
ac_cv_env_CFLAGS_set=
ac_cv_env_CFLAGS_value=
ac_cv_env_CPPFLAGS_set=
ac_cv_env_CPPFLAGS_value=
ac_cv_env_CXXCPP_set=
ac_cv_env_CXXCPP_value=
ac_cv_env_CXXFLAGS_set=set
ac_cv_env_CXXFLAGS_value='-std=c++11 -O3 -Wall -W -Werror'
ac_cv_env_CXX_set=
ac_cv_env_CXX_value=
ac_cv_env_DEPS_CFLAGS_set=
ac_cv_env_DEPS_CFLAGS_value=
ac_cv_env_DEPS_LIBS_set=
ac_cv_env_DEPS_LIBS_value=
ac_cv_env_F77_set=
ac_cv_env_F77_value=
ac_cv_env_FFLAGS_set=
ac_cv_env_FFLAGS_value=
ac_cv_env_LDFLAGS_set=
ac_cv_env_LDFLAGS_value=
ac_cv_env_LIBS_set=
ac_cv_env_LIBS_value=
ac_cv_env_LT_SYS_LIBRARY_PATH_set=
ac_cv_env_LT_SYS_LIBRARY_PATH_value=
ac_cv_env_PKG_CONFIG_LIBDIR_set=
ac_cv_env_PKG_CONFIG_LIBDIR_value=
ac_cv_env_PKG_CONFIG_PATH_set=set
ac_cv_env_PKG_CONFIG_PATH_value=/usr/local/lib/pkgconfig
ac_cv_env_PKG_CONFIG_set=
ac_cv_env_PKG_CONFIG_value=
ac_cv_env_build_alias_set=
ac_cv_env_build_alias_value=
ac_cv_env_host_alias_set=
ac_cv_env_host_alias_value=
ac_cv_env_target_alias_set=
ac_cv_env_target_alias_value=
ac_cv_f77_compiler_gnu=yes
ac_cv_f77_libs=' -L/usr/lib/gcc/x86_64-linux-gnu/11 -L/usr/lib/gcc/x86_64-linux-gnu/11/../../../x86_64-linux-gnu -L/usr/lib/gcc/x86_64-linux-gnu/11/../../../../lib -L/lib/x86_64-linux-gnu -L/lib/../lib -L/usr/lib/x86_64-linux-gnu -L/usr/lib/../lib -L/usr/lib/gcc/x86_64-linux-gnu/11/../../.. -lgfortran -lm -lquadmath'
ac_cv_header_dlfcn_h=yes
ac_cv_header_inttypes_h=yes
ac_cv_header_stdint_h=yes
ac_cv_header_stdio_h=yes
ac_cv_header_stdlib_h=yes
ac_cv_header_string_h=yes
ac_cv_header_strings_h=yes
ac_cv_header_sys_stat_h=yes
ac_cv_header_sys_types_h=yes
ac_cv_header_unistd_h=yes
ac_cv_host=x86_64-pc-linux-gnu
ac_cv_objext=o
ac_cv_path_EGREP='/bin/grep -E'
ac_cv_path_FGREP='/bin/grep -F'
ac_cv_path_GREP=/bin/grep
ac_cv_path_SED=/bin/sed
ac_cv_path_ac_pt_PKG_CONFIG=/bin/pkg-config
ac_cv_path_install='/bin/install -c'
ac_cv_path_lt_DD=/bin/dd
ac_cv_path_mkdir=/bin/mkdir
ac_cv_prog_AWK=mawk
ac_cv_prog_CXXCPP='g++ -E'
ac_cv_prog_ac_ct_AR=ar
ac_cv_prog_ac_ct_CC=gcc
ac_cv_prog_ac_ct_CXX=g++
ac_cv_prog_ac_ct_F77=g77
ac_cv_prog_ac_ct_MANIFEST_TOOL=mt
ac_cv_prog_ac_ct_OBJDUMP=objdump
ac_cv_prog_ac_ct_RANLIB=ranlib
ac_cv_prog_ac_ct_STRIP=strip
ac_cv_prog_cc_c11=
ac_cv_prog_cc_g=yes
ac_cv_prog_cc_stdc=
ac_cv_prog_cxx_11=no
ac_cv_prog_cxx_g=yes
ac_cv_prog_cxx_stdcxx=
ac_cv_prog_f77_g=yes
ac_cv_prog_f77_v=-v
ac_cv_prog_make_make_set=yes
am_cv_CC_dependencies_compiler_type=gcc3
am_cv_CXX_dependencies_compiler_type=gcc3
am_cv_make_support_nested_variables=yes
am_cv_prog_cc_c_o=yes
lt_cv_ar_at_file=@
lt_cv_archive_cmds_need_lc=no
lt_cv_deplibs_check_method=pass_all
lt_cv_file_magic_cmd='$MAGIC_CMD'
lt_cv_file_magic_test_file=
lt_cv_ld_reload_flag=-r
lt_cv_nm_interface='BSD nm'
lt_cv_objdir=.libs
lt_cv_path_LD=/bin/ld
lt_cv_path_LDCXX='/bin/ld -m elf_x86_64'
lt_cv_path_NM='/bin/nm -B'
lt_cv_path_mainfest_tool=no
lt_cv_prog_compiler_c_o=yes
lt_cv_prog_compiler_c_o_CXX=yes
lt_cv_prog_compiler_c_o_F77=yes
lt_cv_prog_compiler_pic='-fPIC -DPIC'
lt_cv_prog_compiler_pic_CXX='-fPIC -DPIC'
lt_cv_prog_compiler_pic_F77=-fPIC
lt_cv_prog_compiler_pic_works=yes
lt_cv_prog_compiler_pic_works_CXX=yes
lt_cv_prog_compiler_pic_works_F77=yes
lt_cv_prog_compiler_rtti_exceptions=no
lt_cv_prog_compiler_static_works=yes
lt_cv_prog_compiler_static_works_CXX=yes
lt_cv_prog_compiler_static_works_F77=yes
lt_cv_prog_gnu_ld=yes
lt_cv_prog_gnu_ldcxx=yes
lt_cv_sharedlib_from_linklib_cmd='printf %s\n'
lt_cv_shlibpath_overrides_runpath=yes
lt_cv_sys_global_symbol_pipe='sed -n -e '\''s/^.*[ ]\([ABCDGIRSTW][ABCDGIRSTW]*\)[ ][ ]*\([_A-Za-z][_A-Za-z0-9]*\)$/\1 \2 \2/p'\'' | sed '\''/ __gnu_lto/d'\'''
lt_cv_sys_global_symbol_to_c_name_address='sed -n -e '\''s/^: \(.*\) .*$/ {"\1", (void *) 0},/p'\'' -e '\''s/^[ABCDGIRSTW][ABCDGIRSTW]* .* \(.*\)$/ {"\1", (void *) \&\1},/p'\'''
lt_cv_sys_global_symbol_to_c_name_address_lib_prefix='sed -n -e '\''s/^: \(.*\) .*$/ {"\1", (void *) 0},/p'\'' -e '\''s/^[ABCDGIRSTW][ABCDGIRSTW]* .* \(lib.*\)$/ {"\1", (void *) \&\1},/p'\'' -e '\''s/^[ABCDGIRSTW][ABCDGIRSTW]* .* \(.*\)$/ {"lib\1", (void *) \&\1},/p'\'''
lt_cv_sys_global_symbol_to_cdecl='sed -n -e '\''s/^T .* \(.*\)$/extern int \1();/p'\'' -e '\''s/^[ABCDGIRSTW][ABCDGIRSTW]* .* \(.*\)$/extern char \1;/p'\'''
lt_cv_sys_global_symbol_to_import=
lt_cv_sys_max_cmd_len=1572864
lt_cv_to_host_file_cmd=func_convert_file_noop
lt_cv_to_tool_file_cmd=func_convert_file_noop
lt_cv_truncate_bin='/bin/dd bs=4096 count=1'
pkg_cv_DEPS_CFLAGS=-I/usr/local/include
pkg_cv_DEPS_LIBS='-L/usr/local/lib -lfftw3 -lgeners -lkstest'
## ----------------- ##
## Output variables. ##
## ----------------- ##
ACLOCAL='${SHELL} '\''/home/igv/Hepforge/npstat/trunk/missing'\'' aclocal-1.16'
AMDEPBACKSLASH='\'
AMDEP_FALSE='#'
AMDEP_TRUE=''
AMTAR='$${TAR-tar}'
AM_BACKSLASH='\'
AM_DEFAULT_V='$(AM_DEFAULT_VERBOSITY)'
AM_DEFAULT_VERBOSITY='1'
AM_V='$(V)'
AR='ar'
AUTOCONF='${SHELL} '\''/home/igv/Hepforge/npstat/trunk/missing'\'' autoconf'
AUTOHEADER='${SHELL} '\''/home/igv/Hepforge/npstat/trunk/missing'\'' autoheader'
AUTOMAKE='${SHELL} '\''/home/igv/Hepforge/npstat/trunk/missing'\'' automake-1.16'
AWK='mawk'
CC='gcc'
CCDEPMODE='depmode=gcc3'
CFLAGS='-g -O2'
CPPFLAGS=''
CSCOPE='cscope'
CTAGS='ctags'
CXX='g++'
CXXCPP='g++ -E'
CXXDEPMODE='depmode=gcc3'
CXXFLAGS='-std=c++11 -O3 -Wall -W -Werror'
CYGPATH_W='echo'
DEFS='-DPACKAGE_NAME=\"npstat\" -DPACKAGE_TARNAME=\"npstat\" -DPACKAGE_VERSION=\"5.9.0\" -DPACKAGE_STRING=\"npstat\ 5.9.0\" -DPACKAGE_BUGREPORT=\"\" -DPACKAGE_URL=\"\" -DPACKAGE=\"npstat\" -DVERSION=\"5.9.0\" -DHAVE_STDIO_H=1 -DHAVE_STDLIB_H=1 -DHAVE_STRING_H=1 -DHAVE_INTTYPES_H=1 -DHAVE_STDINT_H=1 -DHAVE_STRINGS_H=1 -DHAVE_SYS_STAT_H=1 -DHAVE_SYS_TYPES_H=1 -DHAVE_UNISTD_H=1 -DSTDC_HEADERS=1 -DHAVE_DLFCN_H=1 -DLT_OBJDIR=\".libs/\"'
DEPDIR='.deps'
DEPS_CFLAGS='-I/usr/local/include'
DEPS_LIBS='-L/usr/local/lib -lfftw3 -lgeners -lkstest'
DLLTOOL='false'
DSYMUTIL=''
DUMPBIN=''
ECHO_C=''
ECHO_N='-n'
ECHO_T=''
EGREP='/bin/grep -E'
ETAGS='etags'
EXEEXT=''
F77='g77'
FFLAGS='-g -O2'
FGREP='/bin/grep -F'
FLIBS=' -L/usr/lib/gcc/x86_64-linux-gnu/11 -L/usr/lib/gcc/x86_64-linux-gnu/11/../../../x86_64-linux-gnu -L/usr/lib/gcc/x86_64-linux-gnu/11/../../../../lib -L/lib/x86_64-linux-gnu -L/lib/../lib -L/usr/lib/x86_64-linux-gnu -L/usr/lib/../lib -L/usr/lib/gcc/x86_64-linux-gnu/11/../../.. -lgfortran -lm -lquadmath'
GREP='/bin/grep'
INSTALL_DATA='${INSTALL} -m 644'
INSTALL_PROGRAM='${INSTALL}'
INSTALL_SCRIPT='${INSTALL}'
INSTALL_STRIP_PROGRAM='$(install_sh) -c -s'
LD='/bin/ld -m elf_x86_64'
LDFLAGS=''
LIBOBJS=''
LIBS=''
LIBTOOL='$(SHELL) $(top_builddir)/libtool'
LIPO=''
LN_S='ln -s'
LTLIBOBJS=''
LT_SYS_LIBRARY_PATH=''
MAKEINFO='${SHELL} '\''/home/igv/Hepforge/npstat/trunk/missing'\'' makeinfo'
MANIFEST_TOOL=':'
MKDIR_P='/bin/mkdir -p'
NM='/bin/nm -B'
NMEDIT=''
OBJDUMP='objdump'
OBJEXT='o'
OTOOL64=''
OTOOL=''
PACKAGE='npstat'
PACKAGE_BUGREPORT=''
PACKAGE_NAME='npstat'
PACKAGE_STRING='npstat 5.9.0'
PACKAGE_TARNAME='npstat'
PACKAGE_URL=''
PACKAGE_VERSION='5.9.0'
PATH_SEPARATOR=':'
PKG_CONFIG='/bin/pkg-config'
PKG_CONFIG_LIBDIR=''
PKG_CONFIG_PATH='/usr/local/lib/pkgconfig'
RANLIB='ranlib'
SED='/bin/sed'
SET_MAKE=''
SHELL='/bin/bash'
STRIP='strip'
VERSION='5.9.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.9.0"
#define PACKAGE_STRING "npstat 5.9.0"
#define PACKAGE_BUGREPORT ""
#define PACKAGE_URL ""
#define PACKAGE "npstat"
#define VERSION "5.9.0"
#define HAVE_STDIO_H 1
#define HAVE_STDLIB_H 1
#define HAVE_STRING_H 1
#define HAVE_INTTYPES_H 1
#define HAVE_STDINT_H 1
#define HAVE_STRINGS_H 1
#define HAVE_SYS_STAT_H 1
#define HAVE_SYS_TYPES_H 1
#define HAVE_UNISTD_H 1
#define STDC_HEADERS 1
#define HAVE_DLFCN_H 1
#define LT_OBJDIR ".libs/"
configure: exit 0
Index: trunk/tests/Makefile
===================================================================
--- trunk/tests/Makefile (revision 876)
+++ trunk/tests/Makefile (revision 877)
@@ -1,128 +1,128 @@
# Set the following two variables correctly
UTESTPP_DIR = /home/igv/Code/UnitTest++
FFTW_LIBDIR = /usr/local/lib
OFILES_COMMON = test_utils.o
OTESTS_FAST = test_ArrayND.o test_OrthoPoly1D.o test_OrthoPolyND.o \
test_Functors.o test_interpolation.o test_LocalPolyFilterND.o \
test_Distributions1D.o test_InterpolatedDistribution1D.o \
test_EmpiricalCopula.o test_BoxNDScanner.o \
test_QuadraticOrthoPolyND.o test_LocalLogisticRegression.o \
test_randomPermutation.o test_gegenbauerSeriesSum.o \
test_GaussHermiteQuadrature.o test_SpecialFunctions.o \
test_GaussLegendreQuadrature.o test_WeightedStatAccumulator.o \
test_RandomSequenceRepeater.o test_logLikelihoodPeak.o \
test_legendreSeriesSum.o test_solveCubic.o test_HistoND.o \
test_SampleAccumulator.o test_GridInterpolatedDistribution.o \
test_GridAxis.o test_Matrix.o test_StatUtils.o \
test_amiseOptimalBandwidth.o test_OrderedPointND.o \
test_CompositeDistributionND.o test_CompositeBuilder.o \
test_ArchiveIO.o test_Ntuples.o test_LocalQuantileRegression.o \
test_rectangleQuadrature.o test_RegularSampler1D.o \
test_Instantiations.o test_chebyshevSeriesSum.o \
test_dawsonIntegral.o test_NMCombinationSequencer.o \
test_CrossCovarianceAccumulator.o test_StatAccumulatorPair.o \
test_findPeak2D.o test_StatAccumulatorArr.o test_SeriesCGF1D.o \
test_goldenSectionSearch.o test_empiricalQuantile.o \
test_StatAccumulator.o test_binomialCoefficient.o \
test_CircularMapper1d.o test_LinInterpolatedTableND.o \
test_StorableMultivariateFunctor.o test_NeymanPearsonWindow1D.o \
test_hermiteSeriesSum.o test_hermiteSeriesSumPhys.o \
test_DiscreteDistributions1D.o test_LocalPolyFilter1D.o \
test_definiteIntegrals.o test_ExpMapper1d.o test_MathUtils.o \
test_MemoizingSymbetaFilterProvider.o test_ResponseMatrix.o \
test_gaussianResponseMatrix.o test_RectangleQuadrature1D.o \
WeightedTestAccumulator.o TestAccumulator.o test_histoUtils.o \
test_LocalMultiFilter1D.o test_InterpolatedCompositeBuilder.o \
test_DensityAveScanND.o test_Distro1DBuilder.o \
test_findRootNewtonRaphson.o test_cumulantUncertainties.o \
test_ClassicalOrthoPolys1D.o test_ContOrthoPoly1D.o \
test_findRootUsingBisections.o test_orthoPoly1DVProducts.o \
test_truncatedInverseSqrt.o test_FejerQuadrature.o \
test_matrixIndexPairs.o test_KDE1DKernel.o test_Interval.o \
test_likelihoodStatisticCumulants.o test_Uncertainties.o \
test_DistributionsND.o EdgeworthSeries1DOld.o test_OSDE1D.o \
test_SequentialPolyFilterND.o test_HeatEq1DNeumannBoundary.o \
test_ScalableClassicalOrthoPoly1D.o LogLogQuadratic1D.o \
test_Poly1D.o test_LOrPE1DVariableDegreeCVRunner.o \
- test_KDTree.o
+ test_KDTree.o test_vectorAsText.o
OTESTS_COMPREHENSIVE = test_ArrayND_cmh.o test_DiscreteBernstein.o \
test_rescanArray_cmh.o test_LOrPE1DCV.o \
test_LOrPE1DSymbetaKernel.o test_lorpeMise1D.o \
test_solveForLOrPEWeights.o
# OPTIMIZE = -std=c++11 -g -ggdb -O0
OPTIMIZE = -std=c++11 -O3
INCLUDES = -I. -I.. -I$(UTESTPP_DIR)/src -I$(FFTW_LIBDIR)/../include
CPPFLAGS = $(OPTIMIZE) $(INCLUDES) -Wall -W -Werror -Wno-unused-parameter
LIBS = -L../npstat/.libs -lnpstat -L$(UTESTPP_DIR) -lUnitTest++ \
-L$(FFTW_LIBDIR) -lfftw3 -llapack -lblas \
-L/usr/local/lib -lrk -lgeners -lbz2 -lz -lkstest -lm
%.o : %.cc
g++ -c $(CPPFLAGS) -fPIC -MD $< -o $@
@sed -i 's,\($*\.o\)[:]*\(.*\),$@: $$\(wildcard\2\)\n\1:\2,g' $*.d
# Change the "all" target below to suit your development needs.
# Useful targets which can be included are:
#
# fast fast_run
# comprehensive comprehensive_run
# regression regression_run
#
# The tests inside the "fast" target are a subset of tests from the
# "comprehensive" target
all: fast fast_run
# all: fast regression fast_run regression_run
# all: comprehensive comprehensive_run regression regression_run
fast: test_main.o $(OTESTS_FAST) $(OFILES_COMMON)
rm -f $@
g++ $(OPTIMIZE) -fPIC -o $@ $^ $(LIBS)
fast_run: fast
./fast
comprehensive: test_main.o $(OTESTS_FAST) \
$(OTESTS_COMPREHENSIVE) $(OFILES_COMMON)
rm -f $@
g++ $(OPTIMIZE) -fPIC -o $@ $^ $(LIBS)
comprehensive_run: comprehensive
./comprehensive
regression:
regression_run: regression
@ echo Running regression tests.
PROGRAMS = kdtree_speed.cc quantileBinFromCdf.cc incompleteGamma.cc \
convertToSpherical.cc printPermutations.cc showIOTraits.cc \
hugeNtuple.cc hugeNtupleRead.cc histoStdev.cc effectiveDim.cc \
buildInterpolatedCheck.cc legendreRoots.cc jacobiPolyStats.cc \
jacobiVProducts.cc jacobiEpsTest.cc gauss2DRandom.cc besselK.cc
PROGRAMS += cpp11Random.cc
PROGRAMS += failingTest.cc
BINARIES = $(PROGRAMS:.cc=)
binaries: $(BINARIES)
$(BINARIES): % : %.o $(OFILES_COMMON); g++ $(OPTIMIZE) -fPIC -o $@ $^ $(LIBS)
clean:
rm -f fast comprehensive $(BINARIES) \
*.out core.* *.o *.d *~ *.gsbd *.gsbmf
-include test_main.d
-include $(OFILES_COMMON:.o=.d)
-include $(OTESTS_FAST:.o=.d)
-include $(OTESTS_COMPREHENSIVE:.o=.d)
-include $(PROGRAMS:.cc=.d)
Index: trunk/tests/test_Ntuples.cc
===================================================================
--- trunk/tests/test_Ntuples.cc (revision 876)
+++ trunk/tests/test_Ntuples.cc (revision 877)
@@ -1,688 +1,716 @@
#include <sstream>
#include <numeric>
#include "UnitTest++.h"
#include "test_utils.hh"
#include "npstat/stat/InMemoryNtuple.hh"
#include "npstat/stat/ArchivedNtuple.hh"
#include "npstat/stat/NtupleReference.hh"
#include "npstat/stat/MultivariateSumsqAccumulator.hh"
#include "npstat/stat/MultivariateWeightedSumAccumulator.hh"
#include "npstat/stat/NtHistoFill.hh"
#include "npstat/stat/NtNtupleFill.hh"
#include "npstat/stat/NtRectangularCut.hh"
#include "npstat/stat/HistoND.hh"
#include "geners/StringArchive.hh"
#include "geners/BinaryFileArchive.hh"
#define STORE_COLUMNWISE true
using namespace npstat;
using namespace gs;
using namespace std;
namespace {
class Persistent3
{
public:
inline explicit Persistent3(int n)
: n_(test_rng() > 0.5 ? 2 : 1, n) {}
inline bool operator==(const Persistent3& r) const
{return n_ == r.n_;}
inline bool operator!=(const Persistent3& r) const
{return !(*this == r);}
inline gs::ClassId classId() const {return gs::ClassId(*this);}
inline bool write(std::ostream& os) const
{
gs::write_pod_vector(os, n_);
return !os.bad() && !os.fail();
}
static inline const char* classname() {return "npstat::test::Persistent3";}
static inline unsigned version() {return 1;}
static inline Persistent3* read(const gs::ClassId& id, std::istream& in)
{
assert(id == gs::ClassId::makeId<Persistent3>());
Persistent3* dummy = new Persistent3(0);
gs::read_pod_vector(in, &dummy->n_);
assert(!(in.bad() || in.fail()));
return dummy;
}
private:
Persistent3();
std::vector<int> n_;
};
class PassFirstN
{
public:
inline explicit PassFirstN(const unsigned n)
: n_(n) {}
template<typename T>
bool operator()(const unsigned long row, const T*, unsigned long) const
{
return row < n_;
}
private:
unsigned long n_;
};
struct ConstantWeight
{
template<typename T>
inline explicit ConstantWeight(const T& value) : c_(value) {}
template<typename T>
inline double operator()(unsigned long, const T*, unsigned long) const
{return c_;}
private:
double c_;
};
void test_ntuple(AbsNtuple<double>& nt)
{
double buf[3];
for (unsigned i=0; i<1000; ++i)
{
for (unsigned k=0; k<sizeof(buf)/sizeof(buf[0]); ++k)
buf[k] = test_rng();
nt.fill(buf, sizeof(buf)/sizeof(buf[0]));
}
CHECK(nt.nColumns() == 3);
CHECK(nt.nRows() == 1000);
double dsums[3] = {0.0,}, fsums[3] = {0.0,};
for (unsigned i=0; i<1000; ++i)
{
nt.rowContents(i, buf, 3);
for (unsigned k=0; k<3; ++k)
{
CHECK_EQUAL(buf[k], nt(i, k));
dsums[k] += buf[k];
if (i < 100)
fsums[k] += buf[k];
}
}
bool out = false;
try
{
nt.rowContents(1001, buf, 3);
}
catch (std::out_of_range& e)
{
out = true;
}
CHECK(out);
MultivariateSumAccumulator<double> sums;
nt.cycleOverRows(sums);
for (unsigned icol=0; icol<3; ++icol)
CHECK_EQUAL(dsums[icol], sums.sum(icol));
MultivariateSumsqAccumulator<double> sumsqs(sums);
nt.cycleOverRows(sumsqs);
MultivariateWeightedSumAccumulator<double> sumsw;
nt.weightedCycleOverRows(sumsw, ConstantWeight(3.0));
for (unsigned icol=0; icol<3; ++icol)
CHECK_CLOSE(1.0e-12, dsums[icol]*3.0, sumsw.sum(icol));
sums.reset();
nt.conditionalCycleOverRows(PassFirstN(100), sums);
for (unsigned icol=0; icol<3; ++icol)
CHECK_EQUAL(fsums[icol], sums.sum(icol));
CHECK_EQUAL(200UL, nt.conditionalRowCount(PassFirstN(200)));
double colbuf[1000];
for (unsigned icol=0; icol<3; ++icol)
{
nt.columnContents(icol, colbuf, 1000);
for (unsigned i=0; i<1000; ++i)
CHECK_EQUAL(colbuf[i], nt(i, icol));
}
const double ref = nt(1, 2);
CHECK_EQUAL(ref, nt.element(1, Column("c")));
CHECK_EQUAL(ref, nt.element(1, 2));
CHECK_EQUAL(ref, nt.element(1, "c"));
CHECK_EQUAL(ref, nt.element(1, std::string("c")));
unsigned i=0;
const AbsNtuple<double>::column_iterator end = nt.column_end();
for (AbsNtuple<double>::column_iterator it = nt.column_begin("b");
it != end; ++it, ++i)
CHECK_EQUAL(nt(i, 1), *it);
const double sumb = std::accumulate(
nt.column_begin("b"), nt.column_end(), 0.0);
CHECK_EQUAL(dsums[1], sumb);
i=0;
for (AbsNtuple<double>::column_iterator it = nt.column_begin(2);
it < end; ++it, ++i)
CHECK_EQUAL(nt(i, 2), *it);
i=0;
double rowsum = 0.0;
const AbsNtuple<double>::row_iterator cend = nt.row_end();
for (AbsNtuple<double>::row_iterator it = nt.row_begin(10);
it != cend; ++it, ++i)
{
CHECK_EQUAL(nt(10, i), *it);
rowsum += *it;
}
const double sum10 = std::accumulate(
nt.row_begin(10), nt.row_end(), 0.0);
CHECK_EQUAL(rowsum, sum10);
i=0;
for (AbsNtuple<double>::row_iterator it = nt.row_begin(20);
it < cend; ++it, ++i)
CHECK_EQUAL(nt(20, i), *it);
}
void test_obj_ntuple(AbsNtuple<Persistent3>& nt, const bool inMem)
{
AbsNtuple<Persistent3>* nt_add_0(0);
AbsNtuple<Persistent3>* nt_add_1(0);
if (inMem)
{
InMemoryNtuple<Persistent3>& ntmem(
dynamic_cast<InMemoryNtuple<Persistent3>&>(nt));
nt_add_0 = new InMemoryNtuple<Persistent3>(ntmem);
nt_add_1 = new InMemoryNtuple<Persistent3>(ntmem);
}
std::vector<Persistent3> buf;
for (unsigned i=0; i<1000; ++i)
{
buf.clear();
for (unsigned k=0; k<4; ++k)
buf.push_back(Persistent3(static_cast<int>(test_rng()*1000000)));
nt.fill(&buf[0], buf.size());
if (inMem)
{
if (i < 500)
nt_add_0->fill(&buf[0], buf.size());
else
nt_add_1->fill(&buf[0], buf.size());
}
}
if (inMem)
nt_add_0->append(*nt_add_1);
CHECK(nt.nColumns() == 4);
CHECK(nt.nRows() == 1000);
if (inMem)
{
CHECK(*nt_add_0 == nt);
delete nt_add_1;
delete nt_add_0;
}
for (unsigned i=0; i<1000; ++i)
{
nt.rowContents(i, &buf[0], buf.size());
for (unsigned k=0; k<4; ++k)
CHECK(buf[k] == nt(i, k));
}
bool out = false;
try
{
nt.rowContents(1001, &buf[0], buf.size());
}
catch (std::out_of_range& e)
{
out = true;
}
CHECK(out);
std::vector<Persistent3> colbuf(1000,Persistent3(0));
for (unsigned icol=0; icol<4; ++icol)
{
nt.columnContents(icol, &colbuf[0], 1000);
for (unsigned i=0; i<1000; ++i)
CHECK(colbuf[i] == nt(i, icol));
}
const Persistent3 ref(nt(1, 2));
CHECK(ref == nt.element(1, Column("c")));
CHECK(ref == nt.element(1, 2));
CHECK(ref == nt.element(1, "c"));
CHECK(ref == nt.element(1, std::string("c")));
unsigned i=0;
const AbsNtuple<Persistent3>::column_iterator end = nt.column_end();
for (AbsNtuple<Persistent3>::column_iterator it = nt.column_begin("b");
it != end; ++it, ++i)
CHECK(nt(i, 1) == *it);
i=0;
for (AbsNtuple<Persistent3>::column_iterator it = nt.column_begin(2);
it < end; ++it, ++i)
CHECK(nt(i, 2) == *it);
i=0;
const AbsNtuple<Persistent3>::row_iterator cend = nt.row_end();
for (AbsNtuple<Persistent3>::row_iterator it = nt.row_begin(10);
it != cend; ++it, ++i)
CHECK(nt(10, i) == *it);
i=0;
for (AbsNtuple<Persistent3>::row_iterator it = nt.row_begin(20);
it < cend; ++it, ++i)
CHECK(nt(20, i) == *it);
}
TEST(convenienceFill1)
{
const char* vars[] = {"a"};
InMemoryNtuple<double> nt(ntupleColumns(
vars, sizeof(vars)/sizeof(vars[0])));
nt.fill(1.0);
}
TEST(convenienceFill2)
{
const char* vars[] = {"a", "b"};
InMemoryNtuple<double> nt(ntupleColumns(
vars, sizeof(vars)/sizeof(vars[0])));
nt.fill(0.0, 1.0);
}
TEST(convenienceFill3)
{
const char* vars[] = {"a", "b", "c"};
InMemoryNtuple<double> nt(ntupleColumns(
vars, sizeof(vars)/sizeof(vars[0])));
nt.fill(0.0, 1.0, 2.0);
}
TEST(InMemoryNtuple)
{
const char* vars[] = {"a", "b", "c"};
InMemoryNtuple<double> nt(ntupleColumns(
vars, sizeof(vars)/sizeof(vars[0])));
test_ntuple(nt);
std::ostringstream os;
nt.classId().write(os);
nt.write(os);
std::istringstream is(os.str());
gs::ClassId id(is, 1);
AbsNtuple<double>* nt2 = InMemoryNtuple<double>::read(id, is);
CHECK(*nt2 == nt);
delete nt2;
InMemoryNtuple<double> nt3(simpleColumnNames(4));
CHECK(nt3.nColumns() == 4);
CHECK(nt3.columnName(0) == "c0");
CHECK(nt3.columnName(1) == "c1");
CHECK(nt3.columnName(2) == "c2");
CHECK(nt3.columnName(3) == "c3");
}
TEST(ArchivedNtuple)
{
// StringArchive ar("Test Archive");
BinaryFileArchive ar("archive2", "w+", "ArchivedNtuple test");
ArchivedNtuple<double> nt(ntupleColumns("a", "b", "c"), "dummy", ar,
"example ntuple", "my category", 73,
STORE_COLUMNWISE);
test_ntuple(nt);
nt.fill(0.0, 1.0, 2.0);
nt.write();
ar.flush();
CPP11_auto_ptr<ArchivedNtuple<double> > ptr =
NtupleReference<ArchivedNtuple<double> >(
ar, "example ntuple", "my category").get(0);
CHECK(*ptr == nt);
double colbuf[1001];
ptr->columnContents("b", colbuf, 1001);
for (unsigned i=0; i<1000; ++i)
CHECK_EQUAL(colbuf[i], nt(i, 1));
}
TEST(InMemoryObjectNtuple)
{
InMemoryNtuple<Persistent3> nt(ntupleColumns("a", "b", "c", "d"));
CHECK_EQUAL(2UL, nt.columnNumber("c"));
CHECK_EQUAL(4UL, nt.columnNumber("z"));
test_obj_ntuple(nt, true);
std::ostringstream os;
nt.classId().write(os);
nt.write(os);
std::istringstream is(os.str());
gs::ClassId id(is, 1);
AbsNtuple<Persistent3>* nt2 = InMemoryNtuple<Persistent3>::read(id, is);
CHECK(*nt2 == nt);
delete nt2;
}
TEST(ArchivedObjectNtuple)
{
BinaryFileArchive ar("archive3", "w+", "ArchivedObjectNtuple test");
ArchivedNtuple<Persistent3> nt(
ntupleColumns("a", "b", "c", "d"), "test", ar,
"example obj ntuple", "my category", 127, STORE_COLUMNWISE);
test_obj_ntuple(nt, false);
nt.write();
ar.flush();
CPP11_auto_ptr<ArchivedNtuple<Persistent3> > ptr =
NtupleReference<ArchivedNtuple<Persistent3> >(
ar, "example obj ntuple", "my category").get(0);
CHECK(*ptr == nt);
}
TEST(NtupleTextDumpInt)
{
const char* vars[] = {"a", "b", "c"};
const unsigned nvars = sizeof(vars)/sizeof(vars[0]);
InMemoryNtuple<int> nt1(ntupleColumns(vars, nvars));
int buf[nvars];
for (unsigned i=0; i<100; ++i)
{
for (unsigned iv=0; iv<nvars; ++iv)
buf[iv] = static_cast<int>(1000*(test_rng()-0.5));
nt1.fill(buf, nvars);
}
std::ostringstream of;
CHECK(dumpNtupleAsText(nt1, of));
std::istringstream is(of.str());
InMemoryNtuple<int> nt2(ntupleColumns(vars, nvars));
CHECK(fillNtupleFromText(is, &nt2));
CHECK(nt2 == nt1);
}
TEST(NtupleTextDumpDouble)
{
const char* vars[] = {"a", "b", "c"};
const unsigned nvars = sizeof(vars)/sizeof(vars[0]);
InMemoryNtuple<double> nt1(ntupleColumns(vars, nvars));
double buf[nvars];
for (unsigned i=0; i<100; ++i)
{
for (unsigned iv=0; iv<nvars; ++iv)
buf[iv] = 1000.0*(test_rng()-0.5);
nt1.fill(buf, nvars);
}
std::ostringstream of;
of.precision(17);
CHECK(dumpNtupleAsText(nt1, of, true));
std::istringstream is(of.str());
InMemoryNtuple<double> nt2(ntupleColumns(vars, nvars));
CHECK(fillNtupleFromText(is, &nt2, true));
CHECK(nt2 == nt1);
}
+ TEST(NtupleTextDumpFile)
+ {
+ const char* filename = "ntuple_dump.txt";
+
+ const char* vars[] = {"a", "b", "c"};
+ const unsigned nvars = sizeof(vars)/sizeof(vars[0]);
+ InMemoryNtuple<double> nt1(ntupleColumns(vars, nvars));
+ double buf[nvars];
+ for (unsigned i=0; i<100; ++i)
+ {
+ for (unsigned iv=0; iv<nvars; ++iv)
+ buf[iv] = 1000.0*(test_rng()-0.5);
+ nt1.fill(buf, nvars);
+ }
+
+ std::ofstream of(filename);
+ of.precision(17);
+ CHECK(dumpNtupleAsText(nt1, of));
+ of.close();
+
+ std::ifstream is(filename);
+ InMemoryNtuple<double> nt2(ntupleColumns(vars, nvars));
+ CHECK(fillNtupleFromText(is, &nt2));
+ is.close();
+
+ CHECK(nt2 == nt1);
+ }
+
TEST(NtupleTextDumpMulti)
{
const char* vars[] = {"a", "b", "c"};
const unsigned nvars = sizeof(vars)/sizeof(vars[0]);
InMemoryNtuple<double> nt1(ntupleColumns(vars, nvars));
double buf[nvars];
for (unsigned i=0; i<100; ++i)
{
for (unsigned iv=0; iv<nvars; ++iv)
buf[iv] = 1000.0*(test_rng()-0.5);
nt1.fill(buf, nvars);
}
std::ostringstream of;
of.precision(17);
CHECK(dumpNtupleAsText(nt1, of, true));
const char* vars2[] = {"a", "b", "c", "d"};
const unsigned nvars2 = sizeof(vars2)/sizeof(vars2[0]);
InMemoryNtuple<int> nt1_1(ntupleColumns(vars2, nvars2));
int buf2[nvars2];
for (unsigned i=0; i<100; ++i)
{
for (unsigned iv=0; iv<nvars2; ++iv)
buf2[iv] = static_cast<int>(1000*(test_rng()-0.5));
nt1_1.fill(buf2, nvars2);
}
CHECK(dumpNtupleAsText(nt1_1, of, true));
std::istringstream is(of.str());
InMemoryNtuple<double> nt2(ntupleColumns(vars, nvars));
CHECK(fillNtupleFromText(is, &nt2, true, 100));
InMemoryNtuple<int> nt2_2(ntupleColumns(vars2, nvars2));
CHECK(fillNtupleFromText(is, &nt2_2, true));
CHECK(nt2 == nt1);
CHECK(nt2_2 == nt1_1);
}
TEST(NtupleProjOntoNtuple)
{
const char* vars[] = {"a", "b", "c"};
const unsigned nvars = sizeof(vars)/sizeof(vars[0]);
InMemoryNtuple<double> nt1(ntupleColumns(vars, nvars));
double buf[nvars];
for (unsigned i=0; i<1000; ++i)
{
for (unsigned iv=0; iv<nvars; ++iv)
buf[iv] = test_rng();
nt1.fill(buf, nvars);
}
InMemoryNtuple<double> nt2(ntupleColumns(vars, nvars));
NtNtupleFill<InMemoryNtuple<double> > filler(
&nt2, std::vector<unsigned long>());
nt1.cycleOverRows(filler);
CHECK(nt1 == nt2);
}
TEST(NtupleAppendSameType)
{
const char* vars[] = {"a", "b", "c"};
const unsigned nvars = sizeof(vars)/sizeof(vars[0]);
InMemoryNtuple<double> nt1(ntupleColumns(vars, nvars));
InMemoryNtuple<double> nt2(nt1);
InMemoryNtuple<double> nt3(nt1);
double buf[nvars];
for (unsigned i=0; i<1000; ++i)
{
for (unsigned iv=0; iv<nvars; ++iv)
buf[iv] = test_rng();
nt1.fill(buf, nvars);
if (i < 500)
nt2.fill(buf, nvars);
else
nt3.fill(buf, nvars);
}
nt2.append(nt3);
CHECK(nt1 == nt2);
}
TEST(NtupleAppendOtherType)
{
const char* vars[] = {"a", "b", "c"};
const unsigned nvars = sizeof(vars)/sizeof(vars[0]);
InMemoryNtuple<float> nt1(ntupleColumns(vars, nvars));
InMemoryNtuple<float> nt2(nt1);
InMemoryNtuple<double> nt3(ntupleColumns(vars, nvars));
double buf[nvars];
float fbuf[nvars];
for (unsigned i=0; i<1000; ++i)
{
for (unsigned iv=0; iv<nvars; ++iv)
{
buf[iv] = test_rng();
fbuf[iv] = static_cast<float>(buf[iv]);
}
nt1.fill(fbuf, nvars);
if (i < 500)
nt2.fill(fbuf, nvars);
else
nt3.fill(buf, nvars);
}
nt2.append(nt3);
CHECK(nt1 == nt2);
}
TEST(NtupleProjOntoHisto)
{
const char* vars[] = {"a", "b", "c"};
const unsigned nvars = sizeof(vars)/sizeof(vars[0]);
InMemoryNtuple<double> nt1(ntupleColumns(vars, nvars));
double buf[nvars];
for (unsigned i=0; i<1000; ++i)
{
for (unsigned iv=0; iv<nvars; ++iv)
buf[iv] = test_rng();
nt1.fill(buf, nvars);
}
std::vector<HistoAxis> axes;
axes.push_back(HistoAxis(10, 0.2, 0.9));
axes.push_back(HistoAxis(15, -0.1, 1.3));
HistoND<double> h1(axes);
HistoND<double> h2(axes);
NtHistoFill<HistoND<double> > filler(&h1, nt1.columnIndices("c", "b"),
nt1.validColumn("a"));
nt1.cycleOverRows(filler);
const unsigned long nr = nt1.nRows();
for (unsigned long r=0; r<nr; ++r)
{
nt1.rowContents(r, buf, nvars);
h2.fill(buf[2], buf[1], buf[0]);
}
CHECK(h1 == h2);
h1.clear();
h2.clear();
NtHistoFill<HistoND<double>,true> filler3(&h1,
nt1.columnIndices("c", "b"),
nt1.validColumn("a"));
nt1.cycleOverRows(filler3);
for (unsigned long r=0; r<nr; ++r)
{
nt1.rowContents(r, buf, nvars);
h2.fillC(buf[2], buf[1], buf[0]);
}
CHECK(h1 == h2);
h1.clear();
h2.clear();
NtHistoFill<HistoND<double>,true> filler4(&h1,
nt1.columnIndices("c", "b"));
nt1.cycleOverRows(filler4);
for (unsigned long r=0; r<nr; ++r)
{
nt1.rowContents(r, buf, nvars);
h2.fillC(buf[2], buf[1], 1.0);
}
CHECK(h1 == h2);
h1.clear();
h2.clear();
NtHistoFill<HistoND<double> > filler5(&h1, nt1.columnIndices("c", "b"));
nt1.cycleOverRows(filler5);
for (unsigned long r=0; r<nr; ++r)
{
nt1.rowContents(r, buf, nvars);
h2.fill(buf[2], buf[1], 1.0);
}
CHECK(h1 == h2);
h1.clear();
h2.clear();
NtHistoFill<HistoND<double> > filler2(&h1, nt1.columnIndices("b", "c"));
nt1.cycleOverRows(filler2);
for (unsigned long r=0; r<nr; ++r)
{
nt1.rowContents(r, buf, nvars);
h2.fill(buf[1], buf[2], 1.0);
}
CHECK(h1 == h2);
NtRectangularCut<double> cut;
cut.addCut(nt1.validColumn("a"), -1.0f, 2.0f).
addCut(nt1.validColumn("b"), -3.0f, 3.0f);
h1.clear();
nt1.conditionalCycleOverRows(cut, filler2);
CHECK(h1 == h2);
NtRectangularCut<double> cut2(nt1.validColumn("a"), -1.0f, 0.0f,
nt1.validColumn("b"), -3.0f, 0.0f);
h1.clear();
nt1.conditionalCycleOverRows(cut2, filler2);
CHECK(h1 != h2);
ostringstream os;
CHECK(cut.classId().write(os));
CHECK(cut.write(os));
std::istringstream is(os.str());
gs::ClassId id(is, 1);
NtRectangularCut<double> readback;
NtRectangularCut<double>::restore(id, is, &readback);
CHECK(readback == cut);
NtRectangularCut<double> cut3(cut2.ntupleColumns(),
cut2.acceptedBox());
CHECK(cut2 == cut3);
NtRectangularCut<double> cut4(nt1.validColumn("a"), 1.0f, 0.0f,
nt1.validColumn("b"), -3.0f, 0.0f);
NtRectangularCut<double> cut5(cut4.ntupleColumns(),
cut4.acceptedBox());
CHECK(cut4 == cut5);
NtRectangularCut<double> cut6;
cut6.addCut(cut5);
CHECK(cut6 == cut5);
NtRectangularCut<double> cut7(nt1.validColumn("a"), 1.0f, 0.0f,
nt1.validColumn("b"), -3.0f, 0.0f,
nt1.validColumn("a"), 3.0f, 4.0f);
CHECK(cut7.nUniqueColumns() == 2UL);
CHECK(cut7.dim() == 3UL);
NtRectangularCut<float> cut8;
cut8.addCut(cut5);
}
}
Index: trunk/tests/test_vectorAsText.cc
===================================================================
--- trunk/tests/test_vectorAsText.cc (revision 0)
+++ trunk/tests/test_vectorAsText.cc (revision 877)
@@ -0,0 +1,51 @@
+#include <fstream>
+
+#include "UnitTest++.h"
+#include "test_utils.hh"
+
+#include "npstat/nm/vectorAsText.hh"
+
+using namespace npstat;
+using namespace std;
+
+namespace {
+ TEST(vectorAsText_file)
+ {
+ const char* filename = "vectorAsText.txt";
+
+ const unsigned npt = 17;
+ std::vector<double> buf(npt);
+ for (unsigned i=0; i<npt; ++i)
+ buf[i] = test_rng();
+
+ ofstream of(filename);
+ of.precision(17);
+ CHECK(dumpVectorAsText(buf, of));
+ of.close();
+
+ ifstream is(filename);
+ std::vector<double> rb;
+ CHECK(fillVectorFromText(is, &rb));
+ is.close();
+
+ CHECK(buf == rb);
+ }
+
+ TEST(vectorAsText_string)
+ {
+ const unsigned npt = 17;
+ std::vector<double> buf(npt);
+ for (unsigned i=0; i<npt; ++i)
+ buf[i] = test_rng();
+
+ std::ostringstream of;
+ of.precision(17);
+ CHECK(dumpVectorAsText(buf, of));
+
+ std::istringstream is(of.str());
+ std::vector<double> rb;
+ CHECK(fillVectorFromText(is, &rb));
+
+ CHECK(buf == rb);
+ }
+}
Index: trunk/autom4te.cache/requests
===================================================================
--- trunk/autom4te.cache/requests (revision 876)
+++ trunk/autom4te.cache/requests (revision 877)
@@ -1,473 +1,473 @@
# This file was generated by Autom4te 2.71.
# It contains the lists of macros which have been traced.
# It can be safely removed.
@request = (
bless( [
'0',
1,
[
'/usr/share/autoconf'
],
[
'/usr/share/autoconf/m4sugar/m4sugar.m4',
'/usr/share/autoconf/m4sugar/m4sh.m4',
'/usr/share/autoconf/autoconf/autoconf.m4',
'aclocal.m4',
'/dev/null'
],
{
- 'm4_define' => 1,
- 'AC_FC_PP_SRCEXT' => 1,
- 'AC_DEFINE_TRACE_LITERAL' => 1,
- 'AM_MAKEFILE_INCLUDE' => 1,
- 'LT_INIT' => 1,
- 'AC_CONFIG_LINKS' => 1,
- 'AC_PROG_LIBTOOL' => 1,
- '_AM_COND_ELSE' => 1,
- 'AC_SUBST' => 1,
- 'AC_CANONICAL_BUILD' => 1,
- 'LT_SUPPORTED_TAG' => 1,
- 'AC_CONFIG_LIBOBJ_DIR' => 1,
- 'AM_PROG_CXX_C_O' => 1,
- 'AH_OUTPUT' => 1,
- 'AC_CANONICAL_HOST' => 1,
- 'AM_EXTRA_RECURSIVE_TARGETS' => 1,
+ 'AC_CONFIG_AUX_DIR' => 1,
+ 'AC_FC_PP_DEFINE' => 1,
'AU_DEFINE' => 1,
- 'AC_CANONICAL_TARGET' => 1,
- 'AM_ENABLE_MULTILIB' => 1,
- 'AC_INIT' => 1,
- '_AM_COND_ENDIF' => 1,
+ 'IT_PROG_INTLTOOL' => 1,
+ 'm4_pattern_allow' => 1,
'AC_FC_SRCEXT' => 1,
- 'm4_include' => 1,
- '_AM_SUBST_NOTMAKE' => 1,
- 'AM_GNU_GETTEXT_INTL_SUBDIR' => 1,
- 'sinclude' => 1,
- 'GTK_DOC_CHECK' => 1,
- 'AM_AUTOMAKE_VERSION' => 1,
- 'AC_FC_FREEFORM' => 1,
+ 'AC_CANONICAL_BUILD' => 1,
'_m4_warn' => 1,
- 'AM_PROG_AR' => 1,
- 'AM_PROG_FC_C_O' => 1,
- 'AC_LIBSOURCE' => 1,
- 'AM_CONDITIONAL' => 1,
- 'AC_CONFIG_SUBDIRS' => 1,
- 'AM_GNU_GETTEXT' => 1,
- 'AC_CONFIG_HEADERS' => 1,
+ 'AC_SUBST_TRACE' => 1,
+ 'AM_ENABLE_MULTILIB' => 1,
+ '_AM_COND_ENDIF' => 1,
+ 'LT_INIT' => 1,
+ 'AM_PROG_MOC' => 1,
+ 'LT_CONFIG_LTDL_DIR' => 1,
'm4_pattern_forbid' => 1,
+ '_AM_COND_ELSE' => 1,
'AM_MAINTAINER_MODE' => 1,
- 'AC_CANONICAL_SYSTEM' => 1,
- 'AM_PROG_MOC' => 1,
- 'AC_CONFIG_MACRO_DIR_TRACE' => 1,
- '_LT_AC_TAGCONFIG' => 1,
- 'AM_NLS' => 1,
- '_AM_COND_IF' => 1,
- 'IT_PROG_INTLTOOL' => 1,
- 'include' => 1,
+ 'AC_CONFIG_LIBOBJ_DIR' => 1,
+ 'AC_CONFIG_HEADERS' => 1,
+ 'AC_CONFIG_SUBDIRS' => 1,
+ 'AM_AUTOMAKE_VERSION' => 1,
+ 'AM_PROG_MKDIR_P' => 1,
+ 'AC_LIBSOURCE' => 1,
'AM_INIT_AUTOMAKE' => 1,
- 'AC_FC_PP_DEFINE' => 1,
- 'define' => 1,
- '_AM_MAKEFILE_INCLUDE' => 1,
+ 'AC_DEFINE_TRACE_LITERAL' => 1,
+ 'sinclude' => 1,
+ 'AM_XGETTEXT_OPTION' => 1,
+ 'AC_CANONICAL_TARGET' => 1,
+ 'AM_PROG_AR' => 1,
'AC_REQUIRE_AUX_FILE' => 1,
- 'AM_POT_TOOLS' => 1,
- 'LT_CONFIG_LTDL_DIR' => 1,
+ 'AC_FC_FREEFORM' => 1,
+ 'AM_GNU_GETTEXT_INTL_SUBDIR' => 1,
+ 'LT_SUPPORTED_TAG' => 1,
'm4_sinclude' => 1,
- 'AC_SUBST_TRACE' => 1,
+ '_LT_AC_TAGCONFIG' => 1,
+ 'include' => 1,
+ 'm4_define' => 1,
+ 'AC_FC_PP_SRCEXT' => 1,
+ 'AC_PROG_LIBTOOL' => 1,
+ 'AM_PROG_CC_C_O' => 1,
+ 'AM_GNU_GETTEXT' => 1,
+ 'AM_PROG_F77_C_O' => 1,
+ 'AM_PROG_FC_C_O' => 1,
+ 'AC_CONFIG_FILES' => 1,
+ 'AH_OUTPUT' => 1,
'AM_PATH_GUILE' => 1,
+ '_AM_MAKEFILE_INCLUDE' => 1,
+ 'AC_CANONICAL_HOST' => 1,
+ 'AM_PROG_CXX_C_O' => 1,
+ 'AM_NLS' => 1,
+ 'AM_CONDITIONAL' => 1,
+ 'AC_CONFIG_MACRO_DIR_TRACE' => 1,
+ '_AM_COND_IF' => 1,
+ 'GTK_DOC_CHECK' => 1,
'AM_SILENT_RULES' => 1,
- 'AM_PROG_MKDIR_P' => 1,
- 'AC_CONFIG_FILES' => 1,
- 'AC_CONFIG_AUX_DIR' => 1,
- 'm4_pattern_allow' => 1,
- 'AM_XGETTEXT_OPTION' => 1,
- 'AM_PROG_F77_C_O' => 1,
+ 'AM_EXTRA_RECURSIVE_TARGETS' => 1,
+ 'AC_SUBST' => 1,
+ 'AC_INIT' => 1,
+ 'AM_MAKEFILE_INCLUDE' => 1,
+ 'AC_CONFIG_LINKS' => 1,
+ 'AM_POT_TOOLS' => 1,
+ 'define' => 1,
+ 'm4_include' => 1,
+ '_AM_SUBST_NOTMAKE' => 1,
'AM_PROG_LIBTOOL' => 1,
- 'AM_PROG_CC_C_O' => 1
+ 'AC_CANONICAL_SYSTEM' => 1
}
], 'Autom4te::Request' ),
bless( [
'1',
1,
[
'/usr/share/autoconf'
],
[
'/usr/share/autoconf/autoconf/autoconf.m4f',
'/usr/share/aclocal-1.16/internal/ac-config-macro-dirs.m4',
'/usr/share/aclocal/ltargz.m4',
'/usr/share/aclocal/ltdl.m4',
'/usr/share/aclocal/pkg.m4',
'/usr/share/aclocal-1.16/amversion.m4',
'/usr/share/aclocal-1.16/auxdir.m4',
'/usr/share/aclocal-1.16/cond.m4',
'/usr/share/aclocal-1.16/depend.m4',
'/usr/share/aclocal-1.16/depout.m4',
'/usr/share/aclocal-1.16/extra-recurs.m4',
'/usr/share/aclocal-1.16/init.m4',
'/usr/share/aclocal-1.16/install-sh.m4',
'/usr/share/aclocal-1.16/lead-dot.m4',
'/usr/share/aclocal-1.16/make.m4',
'/usr/share/aclocal-1.16/missing.m4',
'/usr/share/aclocal-1.16/options.m4',
'/usr/share/aclocal-1.16/prog-cc-c-o.m4',
'/usr/share/aclocal-1.16/runlog.m4',
'/usr/share/aclocal-1.16/sanity.m4',
'/usr/share/aclocal-1.16/silent.m4',
'/usr/share/aclocal-1.16/strip.m4',
'/usr/share/aclocal-1.16/substnot.m4',
'/usr/share/aclocal-1.16/tar.m4',
'm4/libtool.m4',
'm4/ltoptions.m4',
'm4/ltsugar.m4',
'm4/ltversion.m4',
'm4/lt~obsolete.m4',
'configure.ac'
],
{
- 'AC_LIBTOOL_SYS_GLOBAL_SYMBOL_PIPE' => 1,
- '_LT_AC_TRY_DLOPEN_SELF' => 1,
- 'AC_LIBTOOL_SYS_HARD_LINK_LOCKS' => 1,
- 'LT_SYS_DLOPEN_SELF' => 1,
- 'AM_SET_DEPDIR' => 1,
- 'AM_EXTRA_RECURSIVE_TARGETS' => 1,
- '_LT_AC_LANG_GCJ' => 1,
- 'AM_PROG_LD' => 1,
- 'LT_SYS_DLOPEN_DEPLIBS' => 1,
- 'AC_PROG_LIBTOOL' => 1,
- 'LT_SYS_MODULE_PATH' => 1,
- 'LT_PROG_GCJ' => 1,
- 'PKG_CHECK_VAR' => 1,
- 'AC_LTDL_DLLIB' => 1,
- 'LT_INIT' => 1,
- 'AC_LIBTOOL_DLOPEN_SELF' => 1,
- '_AC_PROG_LIBTOOL' => 1,
- 'AM_MISSING_PROG' => 1,
- 'AC_LIBTOOL_LANG_C_CONFIG' => 1,
- 'AC_LTDL_PREOPEN' => 1,
- '_m4_warn' => 1,
+ 'LT_LIB_DLLOAD' => 1,
+ 'AC_LIBTOOL_SYS_DYNAMIC_LINKER' => 1,
+ 'AC_LIBTOOL_SYS_LIB_STRIP' => 1,
+ 'AC_WITH_LTDL' => 1,
'AM_AUTOMAKE_VERSION' => 1,
- 'AC_LTDL_OBJDIR' => 1,
- '_LT_AC_SYS_COMPILER' => 1,
+ 'AM_OUTPUT_DEPENDENCY_COMMANDS' => 1,
'_AM_OUTPUT_DEPENDENCY_COMMANDS' => 1,
- 'AC_LIBTOOL_PROG_LD_SHLIBS' => 1,
- 'AM_MAKE_INCLUDE' => 1,
- 'AC_DEFUN_ONCE' => 1,
- 'LT_LIB_M' => 1,
- 'AC_LIBTOOL_PICMODE' => 1,
- 'AC_LIBTOOL_RC' => 1,
+ 'LTOBSOLETE_VERSION' => 1,
+ '_LT_PROG_F77' => 1,
+ 'AM_AUX_DIR_EXPAND' => 1,
+ 'AC_LTDL_SYMBOL_USCORE' => 1,
+ 'LT_OUTPUT' => 1,
+ 'AC_CHECK_LIBM' => 1,
+ 'AM_ENABLE_SHARED' => 1,
'AM_SANITY_CHECK' => 1,
- 'LT_AC_PROG_RC' => 1,
- 'AC_LIBTOOL_LANG_GCJ_CONFIG' => 1,
- 'AC_LIBTOOL_SYS_LIB_STRIP' => 1,
- 'LT_FUNC_DLSYM_USCORE' => 1,
+ 'LT_PROG_RC' => 1,
+ '_AC_PROG_LIBTOOL' => 1,
+ 'AC_LIBTOOL_LINKER_OPTION' => 1,
+ 'LTDL_INSTALLABLE' => 1,
+ '_LT_CC_BASENAME' => 1,
+ '_LT_PROG_CXX' => 1,
+ 'AC_LIBTOOL_PROG_LD_HARDCODE_LIBPATH' => 1,
+ 'AM_PROG_NM' => 1,
+ 'LT_PATH_LD' => 1,
+ 'AC_LIBTOOL_SYS_MAX_CMD_LEN' => 1,
+ '_AC_AM_CONFIG_HEADER_HOOK' => 1,
+ 'm4_include' => 1,
'AM_PROG_LIBTOOL' => 1,
- 'AC_PATH_MAGIC' => 1,
- 'AC_DEPLIBS_CHECK_METHOD' => 1,
- '_LT_AC_FILE_LTDLL_C' => 1,
- 'AM_PROG_INSTALL_SH' => 1,
- 'AC_PROG_LD' => 1,
- 'AC_ENABLE_SHARED' => 1,
- 'PKG_NOARCH_INSTALLDIR' => 1,
- '_LT_AC_LANG_CXX_CONFIG' => 1,
- 'AC_ENABLE_STATIC' => 1,
- 'PKG_INSTALLDIR' => 1,
- 'AC_PROG_EGREP' => 1,
- '_LT_PROG_FC' => 1,
- 'AC_CONFIG_MACRO_DIR' => 1,
+ '_LT_AC_SYS_COMPILER' => 1,
+ 'AC_LIBTOOL_CXX' => 1,
+ 'AC_LIBLTDL_CONVENIENCE' => 1,
+ '_LT_PROG_ECHO_BACKSLASH' => 1,
+ '_LT_AC_TAGVAR' => 1,
+ 'AM_MISSING_PROG' => 1,
+ '_LT_AC_LOCK' => 1,
+ 'LT_CMD_MAX_LEN' => 1,
+ 'LT_AC_PROG_RC' => 1,
+ '_LT_AC_TAGCONFIG' => 1,
+ 'AM_DISABLE_SHARED' => 1,
+ '_AM_MANGLE_OPTION' => 1,
+ 'AC_LIBTOOL_CONFIG' => 1,
+ '_AM_PROG_TAR' => 1,
+ 'AC_LTDL_OBJDIR' => 1,
+ 'AC_LIBTOOL_DLOPEN' => 1,
+ '_LT_PREPARE_SED_QUOTE_VARS' => 1,
'AC_PATH_TOOL_PREFIX' => 1,
+ 'AM_PROG_CC_C_O' => 1,
+ 'AC_LIB_LTDL' => 1,
'AC_LTDL_DLSYM_USCORE' => 1,
- 'AC_LTDL_SYS_DLOPEN_DEPLIBS' => 1,
- '_LT_AC_PROG_CXXCPP' => 1,
- 'AC_ENABLE_FAST_INSTALL' => 1,
- 'LT_CMD_MAX_LEN' => 1,
- '_LT_COMPILER_OPTION' => 1,
+ 'AM_INIT_AUTOMAKE' => 1,
+ '_LT_REQUIRED_DARWIN_CHECKS' => 1,
+ 'AM_MISSING_HAS_RUN' => 1,
+ 'AC_LIBTOOL_OBJDIR' => 1,
'AC_LIBTOOL_LANG_RC_CONFIG' => 1,
- 'AM_RUN_LOG' => 1,
- '_LT_AC_PROG_ECHO_BACKSLASH' => 1,
- 'AC_CHECK_LIBM' => 1,
- '_LT_PROG_F77' => 1,
- '_LT_LINKER_OPTION' => 1,
+ '_AM_SET_OPTION' => 1,
+ '_LT_AC_LANG_C_CONFIG' => 1,
'AC_LIBTOOL_COMPILER_OPTION' => 1,
- 'AC_LIBTOOL_POSTDEP_PREDEP' => 1,
+ '_m4_warn' => 1,
+ 'LT_PROG_GO' => 1,
+ 'LT_SYS_SYMBOL_USCORE' => 1,
+ 'AC_LIBTOOL_LANG_GCJ_CONFIG' => 1,
+ 'LT_SYS_DLOPEN_SELF' => 1,
+ '_LT_AC_LANG_F77_CONFIG' => 1,
+ 'AC_ENABLE_STATIC' => 1,
+ 'LT_FUNC_ARGZ' => 1,
+ 'AM_SILENT_RULES' => 1,
+ 'LT_SYS_DLSEARCH_PATH' => 1,
+ 'PKG_CHECK_VAR' => 1,
+ 'AC_LIBTOOL_LANG_CXX_CONFIG' => 1,
+ 'AC_LIBTOOL_LANG_C_CONFIG' => 1,
+ 'AC_PATH_MAGIC' => 1,
+ 'AC_LTDL_SYS_DLOPEN_DEPLIBS' => 1,
+ '_LT_AC_SHELL_INIT' => 1,
+ '_AM_SUBST_NOTMAKE' => 1,
'LT_AC_PROG_SED' => 1,
+ 'AC_LIBTOOL_GCJ' => 1,
+ 'PKG_NOARCH_INSTALLDIR' => 1,
+ 'LT_FUNC_DLSYM_USCORE' => 1,
+ '_LT_LIBOBJ' => 1,
+ 'AC_LIBTOOL_F77' => 1,
+ 'AM_EXTRA_RECURSIVE_TARGETS' => 1,
+ '_LT_AC_CHECK_DLFCN' => 1,
+ '_LT_DLL_DEF_P' => 1,
+ '_LT_AC_LANG_GCJ' => 1,
'LT_PATH_NM' => 1,
- 'AC_LIBTOOL_LINKER_OPTION' => 1,
- 'LTSUGAR_VERSION' => 1,
- 'AC_LIBTOOL_CXX' => 1,
- 'AC_LIB_LTDL' => 1,
+ 'include' => 1,
+ 'AM_PROG_LD' => 1,
+ 'LT_WITH_LTDL' => 1,
+ 'AC_PROG_EGREP' => 1,
+ 'LT_SYS_MODULE_EXT' => 1,
+ '_LT_LINKER_BOILERPLATE' => 1,
+ '_LT_PROG_LTMAIN' => 1,
+ 'LT_LANG' => 1,
+ '_LT_AC_LANG_RC_CONFIG' => 1,
'PKG_PROG_PKG_CONFIG' => 1,
- '_AM_SUBST_NOTMAKE' => 1,
- 'm4_include' => 1,
- '_AC_AM_CONFIG_HEADER_HOOK' => 1,
- 'AC_LIBTOOL_WIN32_DLL' => 1,
- 'AC_LIBTOOL_PROG_COMPILER_PIC' => 1,
- 'LT_PROG_RC' => 1,
- 'AC_LIBTOOL_F77' => 1,
+ 'AM_SET_LEADING_DOT' => 1,
+ '_LT_AC_LANG_CXX_CONFIG' => 1,
+ 'AC_DISABLE_STATIC' => 1,
+ '_LT_PATH_TOOL_PREFIX' => 1,
+ '_LT_AC_TRY_DLOPEN_SELF' => 1,
+ 'AC_LIBTOOL_SYS_OLD_ARCHIVE' => 1,
+ 'AC_DEPLIBS_CHECK_METHOD' => 1,
+ '_LT_COMPILER_OPTION' => 1,
+ 'AM_SET_DEPDIR' => 1,
+ 'AC_LIBLTDL_INSTALLABLE' => 1,
+ '_PKG_SHORT_ERRORS_SUPPORTED' => 1,
'AM_SET_CURRENT_AUTOMAKE_VERSION' => 1,
+ '_LT_AC_LANG_GCJ_CONFIG' => 1,
+ 'AM_SUBST_NOTMAKE' => 1,
+ 'AC_LIBTOOL_POSTDEP_PREDEP' => 1,
+ 'AC_DEFUN' => 1,
+ '_LT_AC_SYS_LIBPATH_AIX' => 1,
+ 'AM_MAKE_INCLUDE' => 1,
+ '_AM_AUTOCONF_VERSION' => 1,
+ 'AC_LTDL_PREOPEN' => 1,
+ 'AM_ENABLE_STATIC' => 1,
+ 'PKG_CHECK_EXISTS' => 1,
+ '_LT_AC_LANG_CXX' => 1,
+ 'AM_DEP_TRACK' => 1,
+ 'm4_pattern_allow' => 1,
+ 'AC_LIBTOOL_WIN32_DLL' => 1,
+ 'PKG_CHECK_MODULES' => 1,
'_AM_IF_OPTION' => 1,
- 'LTDL_INSTALLABLE' => 1,
- 'AC_LIBLTDL_CONVENIENCE' => 1,
+ 'AU_DEFUN' => 1,
'LT_AC_PROG_EGREP' => 1,
- 'LT_FUNC_ARGZ' => 1,
- 'LT_SYS_DLSEARCH_PATH' => 1,
- 'AM_ENABLE_STATIC' => 1,
- 'AM_PROG_CC_C_O' => 1,
- '_LT_DLL_DEF_P' => 1,
- '_LT_AC_CHECK_DLFCN' => 1,
- 'LT_AC_PROG_GCJ' => 1,
+ 'LT_INIT' => 1,
+ 'LTSUGAR_VERSION' => 1,
+ 'LT_CONFIG_LTDL_DIR' => 1,
+ 'AC_LIBTOOL_SYS_HARD_LINK_LOCKS' => 1,
+ 'AC_LIBTOOL_DLOPEN_SELF' => 1,
+ 'AC_LTDL_SHLIBEXT' => 1,
+ 'AC_LIBTOOL_PROG_CC_C_O' => 1,
+ 'AM_PROG_INSTALL_STRIP' => 1,
+ 'AC_PROG_LD' => 1,
+ 'AM_PROG_INSTALL_SH' => 1,
+ 'AC_LIBTOOL_PROG_COMPILER_PIC' => 1,
+ 'AC_LTDL_SHLIBPATH' => 1,
+ '_LT_WITH_SYSROOT' => 1,
+ '_LT_AC_FILE_LTDLL_C' => 1,
+ 'AC_LIBTOOL_SYS_GLOBAL_SYMBOL_PIPE' => 1,
+ 'LT_SYS_DLOPEN_DEPLIBS' => 1,
+ 'AM_DISABLE_STATIC' => 1,
'LTDL_INIT' => 1,
- 'AC_LIBTOOL_GCJ' => 1,
- 'LTVERSION_VERSION' => 1,
- '_LT_AC_LANG_F77_CONFIG' => 1,
- '_LT_CC_BASENAME' => 1,
- '_LT_AC_SYS_LIBPATH_AIX' => 1,
- 'AM_ENABLE_SHARED' => 1,
- '_PKG_SHORT_ERRORS_SUPPORTED' => 1,
- 'AC_DEFUN' => 1,
+ '_LT_AC_LANG_F77' => 1,
+ 'LT_AC_PROG_GCJ' => 1,
+ 'PKG_CHECK_MODULES_STATIC' => 1,
+ 'AC_LIBTOOL_PROG_COMPILER_NO_RTTI' => 1,
+ 'AC_LIBTOOL_LANG_F77_CONFIG' => 1,
+ 'AC_LIBTOOL_PICMODE' => 1,
+ 'LT_PROG_GCJ' => 1,
+ 'AC_DISABLE_FAST_INSTALL' => 1,
+ '_AM_CONFIG_MACRO_DIRS' => 1,
+ 'AC_LTDL_DLLIB' => 1,
+ 'LT_SYS_MODULE_PATH' => 1,
+ 'AC_PROG_LD_RELOAD_FLAG' => 1,
+ 'AC_LTDL_SYSSEARCHPATH' => 1,
+ 'AC_LIBTOOL_PROG_LD_SHLIBS' => 1,
+ 'LT_LIB_M' => 1,
+ 'AC_ENABLE_SHARED' => 1,
+ 'AC_PROG_NM' => 1,
+ '_AM_DEPENDENCIES' => 1,
+ 'PKG_INSTALLDIR' => 1,
+ 'AM_RUN_LOG' => 1,
+ 'AC_DEFUN_ONCE' => 1,
+ '_LT_AC_PROG_ECHO_BACKSLASH' => 1,
'AC_PROG_LD_GNU' => 1,
- 'AC_WITH_LTDL' => 1,
- '_LT_AC_SHELL_INIT' => 1,
- '_LT_PROG_LTMAIN' => 1,
- '_LT_AC_TAGVAR' => 1,
+ '_LT_AC_PROG_CXXCPP' => 1,
+ 'm4_pattern_forbid' => 1,
+ '_LT_PROG_FC' => 1,
+ '_LT_LINKER_OPTION' => 1,
+ '_AM_SET_OPTIONS' => 1,
'AC_DISABLE_SHARED' => 1,
- 'AC_LIBTOOL_LANG_F77_CONFIG' => 1,
- '_LTDL_SETUP' => 1,
- 'AC_LTDL_SYMBOL_USCORE' => 1,
'LTDL_CONVENIENCE' => 1,
'AM_CONDITIONAL' => 1,
- 'LT_LANG' => 1,
- 'LT_WITH_LTDL' => 1,
- '_LT_AC_LOCK' => 1,
- 'AM_AUX_DIR_EXPAND' => 1,
- '_LT_REQUIRED_DARWIN_CHECKS' => 1,
- 'AC_LTDL_SHLIBEXT' => 1,
- 'AC_LIBTOOL_FC' => 1,
- 'AM_INIT_AUTOMAKE' => 1,
- 'LT_OUTPUT' => 1,
- '_LT_AC_LANG_C_CONFIG' => 1,
- 'PKG_CHECK_EXISTS' => 1,
'AC_CONFIG_MACRO_DIR_TRACE' => 1,
- '_LT_AC_LANG_GCJ_CONFIG' => 1,
- '_LT_PROG_CXX' => 1,
- 'LT_SYS_MODULE_EXT' => 1,
- '_AM_SET_OPTIONS' => 1,
- '_LT_PREPARE_SED_QUOTE_VARS' => 1,
- 'AC_LIBTOOL_PROG_COMPILER_NO_RTTI' => 1,
- 'AC_LIBTOOL_LANG_CXX_CONFIG' => 1,
- 'LT_PATH_LD' => 1,
- 'AM_DISABLE_SHARED' => 1,
'AC_LIBTOOL_SETUP' => 1,
- 'AM_OUTPUT_DEPENDENCY_COMMANDS' => 1,
- '_AM_AUTOCONF_VERSION' => 1,
- 'AM_PROG_INSTALL_STRIP' => 1,
- 'AM_DEP_TRACK' => 1,
+ '_LTDL_SETUP' => 1,
+ 'AC_LIBTOOL_FC' => 1,
+ 'LTVERSION_VERSION' => 1,
+ 'AC_ENABLE_FAST_INSTALL' => 1,
+ 'AC_LTDL_ENABLE_INSTALL' => 1,
'_LT_COMPILER_BOILERPLATE' => 1,
- 'AM_SET_LEADING_DOT' => 1,
- 'LT_CONFIG_LTDL_DIR' => 1,
- 'AC_LIBTOOL_CONFIG' => 1,
- '_LT_PATH_TOOL_PREFIX' => 1,
- 'AM_SILENT_RULES' => 1,
- 'AC_LIBTOOL_PROG_LD_HARDCODE_LIBPATH' => 1,
- 'PKG_CHECK_MODULES' => 1,
- 'AC_PROG_LD_RELOAD_FLAG' => 1,
- 'AC_LIBTOOL_SYS_MAX_CMD_LEN' => 1,
- 'AC_DISABLE_FAST_INSTALL' => 1,
- '_AM_DEPENDENCIES' => 1,
- 'AC_LIBTOOL_PROG_CC_C_O' => 1,
- 'AC_DISABLE_STATIC' => 1,
- '_AM_SET_OPTION' => 1,
- 'AM_MISSING_HAS_RUN' => 1,
- 'LT_LIB_DLLOAD' => 1,
- 'AC_PROG_NM' => 1,
'LT_SUPPORTED_TAG' => 1,
- '_LT_AC_LANG_RC_CONFIG' => 1,
- 'AC_LTDL_ENABLE_INSTALL' => 1,
- 'AC_LIBTOOL_DLOPEN' => 1,
+ 'AC_LIBTOOL_RC' => 1,
'_AM_PROG_CC_C_O' => 1,
- '_AM_PROG_TAR' => 1,
- 'LTOPTIONS_VERSION' => 1,
- 'PKG_CHECK_MODULES_STATIC' => 1,
- '_LT_WITH_SYSROOT' => 1,
- '_AM_CONFIG_MACRO_DIRS' => 1,
- '_LT_AC_LANG_F77' => 1,
- 'include' => 1,
- 'AC_LIBLTDL_INSTALLABLE' => 1,
- 'AM_SUBST_NOTMAKE' => 1,
- 'LTOBSOLETE_VERSION' => 1,
- '_LT_PROG_ECHO_BACKSLASH' => 1,
- '_LT_AC_TAGCONFIG' => 1,
- '_LT_AC_LANG_CXX' => 1,
- 'AC_LTDL_SHLIBPATH' => 1,
- 'AC_LTDL_SYSSEARCHPATH' => 1,
- 'AC_LIBTOOL_SYS_DYNAMIC_LINKER' => 1,
- 'LT_SYS_SYMBOL_USCORE' => 1,
- 'm4_pattern_forbid' => 1,
- '_LT_LIBOBJ' => 1,
- 'AC_LIBTOOL_OBJDIR' => 1,
- 'm4_pattern_allow' => 1,
- 'AU_DEFUN' => 1,
- '_AM_MANGLE_OPTION' => 1,
- 'AC_LIBTOOL_SYS_OLD_ARCHIVE' => 1,
- 'AM_DISABLE_STATIC' => 1,
- 'AM_PROG_NM' => 1,
- '_LT_LINKER_BOILERPLATE' => 1,
- 'LT_PROG_GO' => 1
+ 'AC_CONFIG_MACRO_DIR' => 1,
+ 'AC_PROG_LIBTOOL' => 1,
+ 'LTOPTIONS_VERSION' => 1
}
], 'Autom4te::Request' ),
bless( [
'2',
1,
[
'/usr/share/autoconf'
],
[
'/usr/share/autoconf/autoconf/autoconf.m4f',
'aclocal.m4',
'configure.ac'
],
{
+ 'LT_SUPPORTED_TAG' => 1,
'AM_GNU_GETTEXT_INTL_SUBDIR' => 1,
- 'sinclude' => 1,
- 'GTK_DOC_CHECK' => 1,
- 'AM_AUTOMAKE_VERSION' => 1,
- 'AC_FC_SRCEXT' => 1,
- 'm4_include' => 1,
- '_AM_SUBST_NOTMAKE' => 1,
- 'AC_INIT' => 1,
- 'AM_ENABLE_MULTILIB' => 1,
- '_AM_COND_ENDIF' => 1,
- 'AC_LIBSOURCE' => 1,
- 'AM_CONDITIONAL' => 1,
- 'AM_PROG_AR' => 1,
- 'AM_PROG_FC_C_O' => 1,
+ 'm4_sinclude' => 1,
'AC_FC_FREEFORM' => 1,
- '_m4_warn' => 1,
- '_AM_COND_ELSE' => 1,
- 'AC_CONFIG_LINKS' => 1,
- 'AC_PROG_LIBTOOL' => 1,
- 'LT_INIT' => 1,
'AC_FC_PP_SRCEXT' => 1,
- 'AM_MAKEFILE_INCLUDE' => 1,
- 'AC_DEFINE_TRACE_LITERAL' => 1,
- 'AM_EXTRA_RECURSIVE_TARGETS' => 1,
- 'AC_CANONICAL_TARGET' => 1,
- 'AM_PROG_CXX_C_O' => 1,
- 'AH_OUTPUT' => 1,
+ 'include' => 1,
+ '_LT_AC_TAGCONFIG' => 1,
+ 'AM_PROG_F77_C_O' => 1,
+ 'AM_GNU_GETTEXT' => 1,
+ 'AM_PROG_FC_C_O' => 1,
+ 'AM_PROG_CC_C_O' => 1,
+ 'AC_PROG_LIBTOOL' => 1,
'AC_CANONICAL_HOST' => 1,
- 'LT_SUPPORTED_TAG' => 1,
- 'AC_CONFIG_LIBOBJ_DIR' => 1,
- 'AC_SUBST' => 1,
- 'AC_CANONICAL_BUILD' => 1,
- 'm4_sinclude' => 1,
- 'AC_SUBST_TRACE' => 1,
- 'AM_SILENT_RULES' => 1,
'AM_PATH_GUILE' => 1,
- 'AM_POT_TOOLS' => 1,
- 'LT_CONFIG_LTDL_DIR' => 1,
- 'AC_REQUIRE_AUX_FILE' => 1,
'_AM_MAKEFILE_INCLUDE' => 1,
- 'AM_PROG_F77_C_O' => 1,
- 'AM_PROG_LIBTOOL' => 1,
- 'AM_PROG_CC_C_O' => 1,
- 'm4_pattern_allow' => 1,
- 'AM_XGETTEXT_OPTION' => 1,
- 'AC_CONFIG_AUX_DIR' => 1,
- 'AM_PROG_MKDIR_P' => 1,
'AC_CONFIG_FILES' => 1,
- 'AM_MAINTAINER_MODE' => 1,
+ 'AH_OUTPUT' => 1,
+ 'AM_CONDITIONAL' => 1,
+ 'AC_CONFIG_MACRO_DIR_TRACE' => 1,
+ 'AM_PROG_CXX_C_O' => 1,
+ 'AM_NLS' => 1,
+ '_AM_COND_IF' => 1,
+ 'AM_SILENT_RULES' => 1,
+ 'GTK_DOC_CHECK' => 1,
+ 'AC_SUBST' => 1,
+ 'AC_INIT' => 1,
+ 'AM_EXTRA_RECURSIVE_TARGETS' => 1,
+ '_AM_SUBST_NOTMAKE' => 1,
+ 'm4_include' => 1,
'AC_CANONICAL_SYSTEM' => 1,
+ 'AM_PROG_LIBTOOL' => 1,
+ 'AC_CONFIG_LINKS' => 1,
+ 'AM_MAKEFILE_INCLUDE' => 1,
+ 'AM_POT_TOOLS' => 1,
+ 'IT_PROG_INTLTOOL' => 1,
+ 'AC_CONFIG_AUX_DIR' => 1,
+ 'AC_FC_PP_DEFINE' => 1,
+ 'AC_SUBST_TRACE' => 1,
+ '_m4_warn' => 1,
+ 'AC_FC_SRCEXT' => 1,
+ 'm4_pattern_allow' => 1,
+ 'AC_CANONICAL_BUILD' => 1,
+ 'AM_PROG_MOC' => 1,
+ 'LT_INIT' => 1,
+ '_AM_COND_ENDIF' => 1,
+ 'LT_CONFIG_LTDL_DIR' => 1,
+ 'AM_ENABLE_MULTILIB' => 1,
+ '_AM_COND_ELSE' => 1,
'm4_pattern_forbid' => 1,
'AC_CONFIG_SUBDIRS' => 1,
+ 'AM_PROG_MKDIR_P' => 1,
+ 'AM_AUTOMAKE_VERSION' => 1,
'AC_CONFIG_HEADERS' => 1,
- 'AM_GNU_GETTEXT' => 1,
+ 'AC_CONFIG_LIBOBJ_DIR' => 1,
+ 'AM_MAINTAINER_MODE' => 1,
'AM_INIT_AUTOMAKE' => 1,
- 'AC_FC_PP_DEFINE' => 1,
- 'include' => 1,
- 'AM_NLS' => 1,
- '_AM_COND_IF' => 1,
- 'IT_PROG_INTLTOOL' => 1,
- 'AC_CONFIG_MACRO_DIR_TRACE' => 1,
- 'AM_PROG_MOC' => 1,
- '_LT_AC_TAGCONFIG' => 1
+ 'AC_LIBSOURCE' => 1,
+ 'sinclude' => 1,
+ 'AC_DEFINE_TRACE_LITERAL' => 1,
+ 'AC_REQUIRE_AUX_FILE' => 1,
+ 'AM_PROG_AR' => 1,
+ 'AM_XGETTEXT_OPTION' => 1,
+ 'AC_CANONICAL_TARGET' => 1
}
], 'Autom4te::Request' ),
bless( [
'3',
1,
[
'/usr/share/autoconf'
],
[
'/usr/share/autoconf/autoconf/autoconf.m4f',
'aclocal.m4',
'/usr/share/autoconf/autoconf/trailer.m4',
'configure.ac'
],
{
- 'include' => 1,
- 'AC_FC_PP_DEFINE' => 1,
- 'AM_INIT_AUTOMAKE' => 1,
- '_LT_AC_TAGCONFIG' => 1,
- 'AC_CONFIG_MACRO_DIR_TRACE' => 1,
- 'AM_PROG_MOC' => 1,
- 'IT_PROG_INTLTOOL' => 1,
- '_AM_COND_IF' => 1,
- 'AM_NLS' => 1,
- 'AC_CANONICAL_SYSTEM' => 1,
+ 'AC_DEFINE_TRACE_LITERAL' => 1,
+ 'sinclude' => 1,
+ 'AC_CANONICAL_TARGET' => 1,
+ 'AM_XGETTEXT_OPTION' => 1,
+ 'AM_PROG_AR' => 1,
+ 'AC_REQUIRE_AUX_FILE' => 1,
'AM_MAINTAINER_MODE' => 1,
+ 'AC_CONFIG_LIBOBJ_DIR' => 1,
'AC_CONFIG_HEADERS' => 1,
- 'AM_GNU_GETTEXT' => 1,
+ 'AM_AUTOMAKE_VERSION' => 1,
+ 'AM_PROG_MKDIR_P' => 1,
'AC_CONFIG_SUBDIRS' => 1,
+ 'AC_LIBSOURCE' => 1,
+ 'AM_INIT_AUTOMAKE' => 1,
+ 'AM_ENABLE_MULTILIB' => 1,
+ 'LT_CONFIG_LTDL_DIR' => 1,
+ '_AM_COND_ENDIF' => 1,
+ 'LT_INIT' => 1,
+ 'AM_PROG_MOC' => 1,
'm4_pattern_forbid' => 1,
- 'AM_XGETTEXT_OPTION' => 1,
- 'm4_pattern_allow' => 1,
- 'AM_PROG_CC_C_O' => 1,
- 'AM_PROG_LIBTOOL' => 1,
- 'AM_PROG_F77_C_O' => 1,
- 'AC_CONFIG_FILES' => 1,
- 'AM_PROG_MKDIR_P' => 1,
+ '_AM_COND_ELSE' => 1,
+ 'AC_FC_PP_DEFINE' => 1,
'AC_CONFIG_AUX_DIR' => 1,
- 'LT_CONFIG_LTDL_DIR' => 1,
- 'AM_POT_TOOLS' => 1,
- 'AM_PATH_GUILE' => 1,
- 'AM_SILENT_RULES' => 1,
+ 'IT_PROG_INTLTOOL' => 1,
+ 'AC_CANONICAL_BUILD' => 1,
+ 'm4_pattern_allow' => 1,
+ 'AC_FC_SRCEXT' => 1,
+ '_m4_warn' => 1,
'AC_SUBST_TRACE' => 1,
- 'm4_sinclude' => 1,
- '_AM_MAKEFILE_INCLUDE' => 1,
- 'AC_REQUIRE_AUX_FILE' => 1,
- 'AC_CANONICAL_HOST' => 1,
- 'AM_PROG_CXX_C_O' => 1,
- 'AH_OUTPUT' => 1,
- 'AC_CANONICAL_TARGET' => 1,
'AM_EXTRA_RECURSIVE_TARGETS' => 1,
- 'AC_CANONICAL_BUILD' => 1,
+ 'AC_INIT' => 1,
'AC_SUBST' => 1,
- 'AC_CONFIG_LIBOBJ_DIR' => 1,
- 'LT_SUPPORTED_TAG' => 1,
- 'AC_PROG_LIBTOOL' => 1,
- 'AC_CONFIG_LINKS' => 1,
- '_AM_COND_ELSE' => 1,
- 'AC_DEFINE_TRACE_LITERAL' => 1,
+ 'AM_POT_TOOLS' => 1,
'AM_MAKEFILE_INCLUDE' => 1,
- 'AC_FC_PP_SRCEXT' => 1,
- 'LT_INIT' => 1,
- 'AM_PROG_AR' => 1,
- 'AM_PROG_FC_C_O' => 1,
+ 'AC_CONFIG_LINKS' => 1,
+ 'AM_PROG_LIBTOOL' => 1,
+ 'AC_CANONICAL_SYSTEM' => 1,
+ 'm4_include' => 1,
+ '_AM_SUBST_NOTMAKE' => 1,
+ 'AM_NLS' => 1,
+ 'AM_PROG_CXX_C_O' => 1,
+ 'AC_CONFIG_MACRO_DIR_TRACE' => 1,
'AM_CONDITIONAL' => 1,
- 'AC_LIBSOURCE' => 1,
+ 'GTK_DOC_CHECK' => 1,
+ 'AM_SILENT_RULES' => 1,
+ '_AM_COND_IF' => 1,
+ 'AC_PROG_LIBTOOL' => 1,
+ 'AM_PROG_CC_C_O' => 1,
+ 'AM_PROG_FC_C_O' => 1,
+ 'AM_GNU_GETTEXT' => 1,
+ 'AM_PROG_F77_C_O' => 1,
+ 'AH_OUTPUT' => 1,
+ 'AC_CONFIG_FILES' => 1,
+ 'AC_CANONICAL_HOST' => 1,
+ '_AM_MAKEFILE_INCLUDE' => 1,
+ 'AM_PATH_GUILE' => 1,
'AC_FC_FREEFORM' => 1,
- '_m4_warn' => 1,
- 'AM_AUTOMAKE_VERSION' => 1,
+ 'm4_sinclude' => 1,
'AM_GNU_GETTEXT_INTL_SUBDIR' => 1,
- 'GTK_DOC_CHECK' => 1,
- 'sinclude' => 1,
- '_AM_COND_ENDIF' => 1,
- 'AC_INIT' => 1,
- 'AM_ENABLE_MULTILIB' => 1,
- '_AM_SUBST_NOTMAKE' => 1,
- 'AC_FC_SRCEXT' => 1,
- 'm4_include' => 1
+ 'LT_SUPPORTED_TAG' => 1,
+ 'include' => 1,
+ '_LT_AC_TAGCONFIG' => 1,
+ 'AC_FC_PP_SRCEXT' => 1
}
], 'Autom4te::Request' )
);
File Metadata
Details
Attached
Mime Type
text/x-diff
Expires
Sat, May 3, 6:22 AM (1 d, 13 h)
Storage Engine
blob
Storage Format
Raw Data
Storage Handle
4982996
Default Alt Text
(241 KB)
Attached To
rNPSTATSVN npstatsvn
Event Timeline
Log In to Comment